diff --git a/.gitignore b/.gitignore index 2281194..c331e05 100644 --- a/.gitignore +++ b/.gitignore @@ -1,5 +1,6 @@ # Byte-compiled / optimized / DLL files __pycache__/ +cache/ *.py[cod] *$py.class @@ -160,4 +161,4 @@ cython_debug/ # and can be added to the global gitignore or merged into this file. For a more nuclear # option (not recommended) you can uncomment the following to ignore the entire idea folder. #.idea/ -.ve \ No newline at end of file +.ve diff --git a/README.md b/README.md index 2d8ebc9..b3151d4 100644 --- a/README.md +++ b/README.md @@ -1,2 +1,22 @@ # TDEI-python-osw-quality-metric Quality metric calculator for OSW record + + +# Incoming message + +```json +{ + "datasetId":"", + "intersection_file":"" +} + +``` + +# Outgoing message +```json +{ + "datasetId":"", + "metrics_file":"" +} + +``` diff --git a/requirements.txt b/requirements.txt index 925b578..e2c0454 100644 --- a/requirements.txt +++ b/requirements.txt @@ -1,4 +1,14 @@ fastapi~=0.112.1 python_ms_core~=0.0.22 pydantic_settings~=2.4.0 -uvicorn~=0.30.6 \ No newline at end of file +uvicorn~=0.30.6 +networkx==3.2.1 +geopandas==0.12.2 +osmnx==1.6.0 +dask==2024.5.2 +dask-geopandas==0.3.1 +geonetworkx==0.5.3 +shapely==2.0.1 +numpy==1.26.4 +pandas==1.3.4 +fiona==1.9.6 diff --git a/src/assets/messages/incoming.json b/src/assets/messages/incoming.json index d32e452..2549bac 100644 --- a/src/assets/messages/incoming.json +++ b/src/assets/messages/incoming.json @@ -3,7 +3,8 @@ "messageId": "message-id-from-msg", "data": { "jobId": "0b41ebc5-350c-42d3-90af-3af4ad3628fb", - "data_file": "https://tdeisamplestorage.blob.core.windows.net/osw/test_upload/Archive.zip", - "algorithms": "fixed" + "data_file": "https://tdeisamplestorage.blob.core.windows.net/osw/test/wenatchee.zip", + "algorithm": "fixed", + "sub_regions_file":"" } } \ No newline at end of file diff --git a/src/calculators/__init__.py b/src/calculators/__init__.py index c396f7e..1cbc772 100644 --- a/src/calculators/__init__.py +++ b/src/calculators/__init__.py @@ -1,2 +1,3 @@ from .qm_calculator import QMCalculator -from .qm_fixed_calculator import QMFixedCalculator, QMRandomCalculator \ No newline at end of file +from .qm_fixed_calculator import QMFixedCalculator +from .qm_xn_lib_calculator import QMXNLibCalculator \ No newline at end of file diff --git a/src/calculators/qm_calculator.py b/src/calculators/qm_calculator.py index bf80fa2..ab16a7d 100644 --- a/src/calculators/qm_calculator.py +++ b/src/calculators/qm_calculator.py @@ -1,9 +1,15 @@ from abc import ABC, abstractmethod +from typing import NamedTuple + +class QualityMetricResult(NamedTuple): + success: bool + message: str + output_file: str class QMCalculator(ABC): @abstractmethod - def calculate_quality_metric(self, feature:dict) -> float: + def calculate_quality_metric(self) -> QualityMetricResult: pass @abstractmethod - def qm_metric_tag(self) -> str: - pass \ No newline at end of file + def algorithm_name(self) -> str: + pass diff --git a/src/calculators/qm_fixed_calculator.py b/src/calculators/qm_fixed_calculator.py index 07c2f2b..b2567a9 100644 --- a/src/calculators/qm_fixed_calculator.py +++ b/src/calculators/qm_fixed_calculator.py @@ -1,23 +1,41 @@ -from .qm_calculator import QMCalculator +from src.calculators.qm_calculator import QMCalculator, QualityMetricResult import random - +import geopandas as gpd +import sys class QMFixedCalculator(QMCalculator): - def __init__(self): + ''' + Dummy quality metric calculator that assigns a random score to each edge in the input file + ''' + + def __init__(self, edges_file_path:str, output_file_path:str, polygon_file_path:str=None): + self.edges_file_path = edges_file_path + self.output_file_path = output_file_path + self.polygon_file_path = polygon_file_path pass - - def calculate_quality_metric(self, feature: dict) -> float: - return 10.5 - def qm_metric_tag(self) -> str: - return "ext:qm:fixed" + def calculate_quality_metric(self): + gdf = gpd.read_file(self.edges_file_path) + gdf['fixed_score'] = random.randint(0, 100) + gdf.to_file(self.output_file_path) + return QualityMetricResult(success=True, message="QMFixedCalculator", output_file=self.output_file_path) -class QMRandomCalculator(QMCalculator): - def __init__(self): - pass - - def calculate_quality_metric(self, feature: dict) -> float: - return random.uniform(30, 100) + def algorithm_name(self): + return "QMFixedCalculator" + + +if __name__ == '__main__': + osw_edge_file_path = sys.argv[1] # First argument: OSW edge file path + qm_file_path = sys.argv[2] # Second argument: Quality metric output file path - def qm_metric_tag(self) -> str: - return "ext:qm:random" \ No newline at end of file + # Check if the optional third argument (xn_polygon_path) is provided + if len(sys.argv) > 3: + xn_polygon_path = sys.argv[3] # Third argument: Intersection polygon file path (optional) + qm_calculator = QMFixedCalculator(osw_edge_file_path, qm_file_path, xn_polygon_path) + print(qm_calculator.calculate_quality_metric()) + + else: + # If the third argument is not provided, call without xn_polygon_path + qm_calculator = QMFixedCalculator(osw_edge_file_path, qm_file_path) + print(qm_calculator.calculate_quality_metric()) + \ No newline at end of file diff --git a/src/calculators/qm_xn_lib_calculator.py b/src/calculators/qm_xn_lib_calculator.py new file mode 100644 index 0000000..382d44c --- /dev/null +++ b/src/calculators/qm_xn_lib_calculator.py @@ -0,0 +1,179 @@ +from src.calculators.qm_calculator import QMCalculator, QualityMetricResult +import geopandas as gpd +import sys +import warnings +import networkx as nx +import traceback +import geonetworkx as gnx +import osmnx as ox +import dask_geopandas +from shapely import Point, LineString, MultiLineString, Polygon, MultiPolygon +from shapely.ops import voronoi_diagram +import itertools +import numpy as np +import pandas as pd + + +class QMXNLibCalculator(QMCalculator): + def __init__(self, edges_file_path:str, output_file_path:str, polygon_file_path:str=None): + """ + Initializes the QMXNLibCalculator class. + + Args: + edges_file_path (str): Path to the file containing the OSW edge data. + output_file_path (str): Path to where the output quality metric file will be saved. + polygon_file_path (str, optional): Path to the intersection polygon file. If not provided, will use the polygon computed from the convex hull of OSW edge data. Defaults to None. + """ + self.edges_file_path = edges_file_path + self.output_file_path = output_file_path + self.polygon_file_path = polygon_file_path + warnings.filterwarnings("ignore") + self.default_projection = 'epsg:26910' + self.output_projection = 'epsg:4326' + self.precision = 1e-5 + + def add_edges_from_linestring(self, graph, linestring, edge_attrs): + points = list(linestring.coords) + for start, end in zip(points[:-1], points[1:]): + graph.add_edge(start, end, **edge_attrs) + + def graph_from_gdf(self, gdf): + G = nx.Graph() + for index, row in gdf.iterrows(): + geom = row.geometry + if isinstance(geom, LineString): + self.add_edges_from_linestring(G, geom, row.to_dict()) + elif isinstance(geom, MultiLineString): + for linestring in geom.geoms: + self.add_edges_from_linestring(G, linestring, row.to_dict()) + return G + + def group_G_pts(self, G, poly): + P = poly + node_pts = [Point(x) for x in G.nodes()] + boundary = list(P.boundary.coords) + segments = [LineString([boundary[i], boundary[i + 1]]) for i in range(len(boundary) - 1)] + segment_point_map = {index: [] for index in range(len(segments))} + for point in node_pts: + for idx, segment in enumerate(segments): + if segment.distance(point) < self.precision: + segment_point_map[idx].append((point.x, point.y)) + break + return segment_point_map + + def edges_are_connected(self, G, e1_pts, e2_pts): + for pt1 in e1_pts: + for pt2 in e2_pts: + if nx.has_path(G, pt1, pt2): + return True + return False + + def algorithm_name(self): + return "QMXNLibCalculator" + + def tile_tra_score(self, G, polygon): + # assign each point to a polygon line + pts_line_map = self.group_G_pts(G, polygon) + boundary_nodes = [item for sublist in pts_line_map.values() for item in sublist] + + # find all pair of edges + edge_pairs = list(itertools.combinations_with_replacement(pts_line_map.keys(), 2)) + + n_total = len(edge_pairs) + n_connected = 0 + connected_pairs = list() + for pair in edge_pairs: + is_connected = self.edges_are_connected(G, pts_line_map[pair[0]], pts_line_map[pair[1]]) + if is_connected: + n_connected += 1 + connected_pairs.append(pair) + return n_total, n_connected, connected_pairs + + def get_stats(self, polygon, G, gdf): + stats = {} + undirected_g = nx.Graph(G) + + try: + n_total, n_connected, connected_pairs = self.tile_tra_score(G, polygon) + stats['tra_score'] = n_connected / n_total + except Exception as e: + print(f"Unexpected {e}, {type(e)} with polygon {polygon} when getting number of connected edge pairs") + #traceback.print_exc() + stats["tra_score"] = -1 + return stats + + def get_measures_from_polygon(self, polygon, gdf): + if isinstance(polygon, MultiPolygon) and len(polygon.geoms)==1: + polygon = polygon.geoms[0] + # crop gdf to the polygon + cropped_gdf = gpd.clip(gdf, polygon) + + G = self.graph_from_gdf(cropped_gdf) + stats = self.get_stats(polygon, G, cropped_gdf) + return stats + + def qm_func(self, feature, gdf): + poly = feature.geometry + if (poly.geom_type == 'Polygon' or poly.geom_type == 'MultiPolygon'): + measures = self.get_measures_from_polygon(poly, gdf) + feature.loc['tra_score'] = measures['tra_score'] + return feature + else: + return feature + + def create_voronoi_diagram(self, G_roads_simplified, bounds): + # first thin the nodes + gdf_roads_simplified = gnx.graph_edges_to_gdf(G_roads_simplified) + voronoi = voronoi_diagram(gdf_roads_simplified.boundary.unary_union, envelope=bounds) + voronoi_gdf = gpd.GeoDataFrame({'geometry':voronoi.geoms}) + voronoi_gdf = voronoi_gdf.set_crs(gdf_roads_simplified.crs) + voronoi_gdf_clipped = gpd.clip(voronoi_gdf, bounds) + voronoi_gdf_clipped = voronoi_gdf_clipped.to_crs(self.default_projection) + + return voronoi_gdf_clipped + + def calculate_quality_metric(self): + try: + gdf = gpd.read_file(self.edges_file_path) + + if self.polygon_file_path: + tile_gdf = gpd.read_file(self.polygon_file_path) + else: + unified_geom = gdf.unary_union + bounding_polygon = unified_geom.convex_hull + g_roads_simplified = ox.graph.graph_from_polygon(bounding_polygon, network_type='drive', simplify=True, retain_all=True) + tile_gdf = self.create_voronoi_diagram(g_roads_simplified, bounding_polygon) + + gdf = gdf.to_crs(self.default_projection) + tile_gdf = tile_gdf.to_crs(self.default_projection) + tile_gdf = tile_gdf[['geometry']] + + df_dask = dask_geopandas.from_geopandas(tile_gdf, npartitions=64) + + output = df_dask.apply(self.qm_func,axis=1, meta=[ + ('geometry', 'geometry'), + ('tra_score', 'object') + ], gdf=gdf).compute(scheduler='multiprocessing') + output = output.to_crs(self.output_projection) # The output should be in WGS84 (epsg:4326) + output.to_file(self.output_file_path, driver='GeoJSON') + return QualityMetricResult(success=True, message='QMXNLibCalculator', output_file=self.output_file_path) + + except Exception as e: + print(f"Error {e} occurred when calculating quality metric for data {self.edges_file_path}") + return QualityMetricResult(success=False, message=f'Error: {e}', output_file="") + + +if __name__ == '__main__': + osw_edge_file_path = sys.argv[1] # First argument: OSW edge file path + qm_file_path = sys.argv[2] # Second argument: Quality metric output file path + + # Check if the optional third argument (xn_polygon_path) is provided + if len(sys.argv) > 3: + xn_polygon_path = sys.argv[3] # Third argument: Intersection polygon file path (optional) + qm_calculator = QMXNLibCalculator(osw_edge_file_path, qm_file_path, xn_polygon_path) + print(qm_calculator.calculate_quality_metric()) + + else: + # If the third argument is not provided, call without xn_polygon_path + qm_calculator = QMXNLibCalculator(osw_edge_file_path, qm_file_path) + print(qm_calculator.calculate_quality_metric()) diff --git a/src/calculators/xn_qm_lib.py b/src/calculators/xn_qm_lib.py new file mode 100644 index 0000000..2d72b24 --- /dev/null +++ b/src/calculators/xn_qm_lib.py @@ -0,0 +1,200 @@ +import os +os.environ['USE_PYGEOS'] = '0' # Got to move it somewhere else +import networkx as nx +import sys +import traceback +import geopandas as gpd +import geonetworkx as gnx +import osmnx as ox +import dask_geopandas +from shapely import Point, LineString, MultiLineString, Polygon, MultiPolygon +from shapely.ops import voronoi_diagram +import itertools +import numpy as np +import pandas as pd + +import warnings +warnings.filterwarnings("ignore") + +PROJ = 'epsg:26910' +PRES = 1e-5 + + +def add_edges_from_linestring(graph, linestring, edge_attrs): + points = list(linestring.coords) + #points = [(round(x, 0), round(y, 0)) for x, y in points] #round to meter + for start, end in zip(points[:-1], points[1:]): + graph.add_edge(start, end, **edge_attrs) + + +def graph_from_gdf(gdf): + # Initialize an empty graph + G = nx.Graph() + + # Iterate through each row in the GeoDataFrame + for index, row in gdf.iterrows(): + geom = row.geometry + if isinstance(geom, LineString): + add_edges_from_linestring(G, geom, row.to_dict()) + elif isinstance(geom, MultiLineString): + for linestring in geom.geoms: + add_edges_from_linestring(G, linestring, row.to_dict()) + return G + + +def group_G_pts(G, poly): + P = poly + + node_pts = [Point(x) for x in G.nodes()] + # Get polygon boundary as a list of line segments + boundary = list(P.boundary.coords) + segments = [LineString([boundary[i], boundary[i + 1]]) for i in range(len(boundary) - 1)] + + # Dictionary to hold points grouped by line segments + segment_point_map = {index: [] for index in range(len(segments))} + + # Group points by which line segment they fall on + for point in node_pts: + for idx, segment in enumerate(segments): + if segment.distance(point) < PRES: # Small threshold for precision issues + segment_point_map[idx].append((point.x, point.y)) + break + return segment_point_map + + +def edges_are_connected(G, e1_pts, e2_pts): + for pt1 in e1_pts: + for pt2 in e2_pts: + # node self to self should be count at connected + if pt1 != pt2: + if nx.has_path(G, pt1, pt2): + return True + return False + + +def tile_tra_score(G, polygon): + # assign each point to an polygon line + pts_line_map = group_G_pts(G, polygon) + boundary_nodes = [item for sublist in pts_line_map.values() for item in sublist] + + # find all pair of edges + edge_pairs = list(itertools.combinations_with_replacement(pts_line_map.keys(), 2)) + + n_total = len(edge_pairs) + n_connected = 0 + connected_pairs = list() + for pair in edge_pairs: + is_connected = edges_are_connected(G, pts_line_map[pair[0]], pts_line_map[pair[1]]) + if is_connected: + connected_pairs.append(pair) + n_connected += 1 + + return n_total, n_connected, connected_pairs + + +def get_stats(polygon, G, gdf): + stats = {} + undirected_g = nx.Graph(G) + + # edge-to-edge connected paths + try: + n_total, n_connected, connected_pairs = tile_tra_score(undirected_g, polygon) + stats["tra_score"] = n_connected/n_total + + except Exception as e: + print(f"Unexpected {e}, {type(e)} with polygon {polygon} when getting number of connected edge pairs") + #traceback.print_exc() + stats["tra_score"] = -1 + + return stats + + +def get_measures_from_polygon(polygon, gdf): + if isinstance(polygon, MultiPolygon) and len(polygon.geoms)==1: + polygon = polygon.geoms[0] + + # crop gdf to the polygon + cropped_gdf = gpd.clip(gdf, polygon) + + G = graph_from_gdf(cropped_gdf) + stats = get_stats(polygon, G, cropped_gdf) + + return stats + + +def qm_func(feature, gdf): + poly = feature.geometry + if (poly.geom_type == "Polygon" or poly.geom_type == "MultiPolygon"): + measures = get_measures_from_polygon(poly, gdf) + feature.loc['tra_score'] = measures["tra_score"] + return feature + + +def create_voronoi_diagram(G_roads_simplified, bounds): + # first thin the nodes + gdf_roads_simplified = gnx.graph_edges_to_gdf(G_roads_simplified) + voronoi = voronoi_diagram(gdf_roads_simplified.boundary.unary_union, envelope = bounds) + voronoi_gdf = gpd.GeoDataFrame({"geometry": voronoi.geoms}) + voronoi_gdf = voronoi_gdf.set_crs(gdf_roads_simplified.crs) + voronoi_gdf_clipped = gpd.clip(voronoi_gdf, bounds) + voronoi_gdf_clipped = voronoi_gdf_clipped.to_crs(PROJ) + + return voronoi_gdf_clipped + + +def calculate_xn_qm(osw_edge_file_path: str, qm_file_path: str, xn_polygon_path: str = None): + """ + Calculate and save quality metric for given OSW edge data on an intersection polygons. + + Parameters: + osw_edge_file_path (str): Path to the OSW edge file. + qm_file_path (str): Path where the output quality metric file will be saved. + xn_polygon_path (str, optional): Path to the intersection polygon file. If not provided, will use the polygon files computed from the convex hull of OSW edge data. + """ + try: + gdf = gpd.read_file(osw_edge_file_path) + + if xn_polygon_path: + # Use the provided polygon file + tile_gdf = gpd.read_file(xn_polygon_path) + else: + # Calculate bounding polygon from OSW edge data + unified_geom = gdf.unary_union + bounding_polygon = unified_geom.convex_hull + g_roads_simplified = ox.graph.graph_from_polygon(bounding_polygon, network_type='drive', simplify=True, retain_all=True) + tile_gdf = create_voronoi_diagram(g_roads_simplified, bounding_polygon) + + # Ensure CRS consistency + gdf = gdf.to_crs(PROJ) + tile_gdf = tile_gdf.to_crs(PROJ) + tile_gdf = tile_gdf[['geometry']] + + # Compute local stats using dask-geopandas + df_dask = dask_geopandas.from_geopandas(tile_gdf, npartitions=64) + + # print('computing stats...') + output = df_dask.apply(qm_func, axis=1, meta=[ + ('geometry', 'geometry'), + ('tra_score', 'object'), + ], gdf=gdf).compute(scheduler='multiprocessing') + + output.to_file(qm_file_path, driver='GeoJSON') + + except Exception as e: + print(f"Error {e} occurred when calculating quality metric for data {osw_edge_file_path}") + return -1 + + return None + + +if __name__ == '__main__': + osw_edge_file_path = sys.argv[1] # First argument: OSW edge file path + qm_file_path = sys.argv[2] # Second argument: Quality metric output file path + + # Check if the optional third argument (xn_polygon_path) is provided + if len(sys.argv) > 3: + xn_polygon_path = sys.argv[3] # Third argument: Intersection polygon file path (optional) + print(calculate_xn_qm(osw_edge_file_path, qm_file_path, xn_polygon_path=xn_polygon_path)) + else: + # If the third argument is not provided, call without xn_polygon_path + print(calculate_xn_qm(osw_edge_file_path, qm_file_path)) diff --git a/src/config.py b/src/config.py index 1e166ca..1658626 100644 --- a/src/config.py +++ b/src/config.py @@ -1,7 +1,7 @@ import os from dotenv import load_dotenv from pydantic_settings import BaseSettings -from src.calculators import QMFixedCalculator, QMRandomCalculator +from src.calculators import QMFixedCalculator, QMXNLibCalculator load_dotenv() @@ -12,7 +12,7 @@ class Config(BaseSettings): incoming_topic_subscription: str = os.environ.get('QUALITY_REQ_SUB', '') outgoing_topic_name: str = os.environ.get('QUALITY_RES_TOPIC', '') storage_container_name: str = os.environ.get('CONTAINER_NAME', 'osw') - algorithm_dictionary: dict = {"fixed":QMFixedCalculator, "random":QMRandomCalculator} + algorithm_dictionary: dict = {"fixed":QMFixedCalculator,"ixn":QMXNLibCalculator} max_concurrent_messages: int = os.environ.get('MAX_CONCURRENT_MESSAGES', 1) def get_download_folder(self) -> str: diff --git a/src/models/quality_request.py b/src/models/quality_request.py index 02f64e3..299e783 100644 --- a/src/models/quality_request.py +++ b/src/models/quality_request.py @@ -1,11 +1,13 @@ from dataclasses import dataclass +from typing import Optional @dataclass class RequestData: jobId: str data_file: str - algorithms: str + algorithm: str + sub_regions_file: Optional[str] = None @dataclass diff --git a/src/services/osw_qm_calculator_service.py b/src/services/osw_qm_calculator_service.py index 7ad9ea4..d91d883 100644 --- a/src/services/osw_qm_calculator_service.py +++ b/src/services/osw_qm_calculator_service.py @@ -1,5 +1,6 @@ import zipfile from src.config import Config +from src.calculators import QMXNLibCalculator, QMFixedCalculator, QMCalculator import json import os import tempfile @@ -26,7 +27,7 @@ class OswQmCalculator: """ - def calculate_quality_metric(self, input_file, algorithm_names, output_path): + def calculate_quality_metric(self, input_file, algorithm_names, output_path, ixn_file=None): """ Calculates quality metrics for input files using specified algorithms. @@ -39,24 +40,62 @@ def calculate_quality_metric(self, input_file, algorithm_names, output_path): None """ - with zipfile.ZipFile(input_file, 'r') as input_zip: - input_unzip_folder = tempfile.TemporaryDirectory() - file_list = self.extract_zip(input_zip, input_unzip_folder.name) - logger.info(f"Extracted input files: {file_list}") - input_files_path = [os.path.join(input_unzip_folder.name, file) for file in file_list] - output_unzip_folder = tempfile.TemporaryDirectory() - logger.info(f"Started calculating quality metrics for input files: {input_files_path}") - for input_file in input_files_path: - qm_calculated_json = self.parse_and_calculate_quality_metric(input_file, algorithm_names) - qm_calculated_file_path = os.path.join(output_unzip_folder.name, os.path.basename(input_file)) - with open(qm_calculated_file_path, 'w') as qm_file: - json.dump(qm_calculated_json, qm_file) - logger.info(f"Finished calculating quality metrics for input files: {input_files_path}") - logger.info(f'Zipping output files to {output_path}') - self.zip_folder(output_unzip_folder.name, output_path) - logger.info(f'Cleaning up temporary folders.') - input_unzip_folder.cleanup() - output_unzip_folder.cleanup() + try: + with zipfile.ZipFile(input_file, 'r') as input_zip: + input_unzip_folder = tempfile.TemporaryDirectory() + input_files_path = self.extract_zip(input_zip, input_unzip_folder.name) + # logging.info(f"Extracted input files: {file_list}") + # input_files_path = [os.path.join(input_unzip_folder.name, file) for file in file_list] + output_unzip_folder = tempfile.TemporaryDirectory() + logger.info(f"Started calculating quality metrics for input files: {input_files_path}") + # Get only the edges file out of the input files + edges_file_path = [file_path for file_path in input_files_path if 'edges' in file_path] + if len(edges_file_path) == 0: + raise Exception('Edges file not found in input files.') + edges_file_path = edges_file_path[0] + edges_file_basename = os.path.basename(edges_file_path) + edges_file_without_extension = os.path.splitext(edges_file_basename)[0] + for algorithm_name in algorithm_names: + qm_edges_output_path = os.path.join(output_unzip_folder.name, f'{algorithm_name}_qm.geojson') + qm_calculator = self.get_osw_qm_calculator(algorithm_name, ixn_file, edges_file_path, qm_edges_output_path) + start_time = time.time() + qm_calculator.calculate_quality_metric() + end_time = time.time() + logger.info(f"Time taken to calculate quality metrics for {algorithm_name}: {end_time - start_time} seconds") + # Copy the rest of the files from input to output + # Dont copy the other files here. + # for file_path in input_files_path: + # if 'edges' in file_path: + # continue + # file_basename = os.path.basename(file_path) + # output_file_path = os.path.join(output_unzip_folder.name, file_basename) + # os.rename(file_path, output_file_path) + + logger.info(f"Finished calculating quality metrics for input files: {input_files_path}") + logger.info(f'Zipping output files to {output_path}') + self.zip_folder(output_unzip_folder.name, output_path) + logger.info(f'Cleaning up temporary folders.') + input_unzip_folder.cleanup() + output_unzip_folder.cleanup() + except Exception as e: + logging.error(f'Error calculating quality metrics: {e}') + raise e + + def get_osw_qm_calculator(self, algorithm_name:str, ixn_file:str=None, edges_file:str=None, output_file:str=None) -> QMCalculator: + """ + Returns an instance of the specified quality metric calculator. + + Args: + algorithm_name (str): The name of the quality metric calculator. + + Returns: + QMCalculator: An instance of the specified quality metric calculator. + + """ + if algorithm_name == 'ixn': + return QMXNLibCalculator(edges_file, output_file, ixn_file) + else: + return QMFixedCalculator(edges_file, output_file) def zip_folder(self, input_folder, output_zip): """ @@ -70,7 +109,6 @@ def zip_folder(self, input_folder, output_zip): None """ - print(output_zip) with zipfile.ZipFile(output_zip, 'w') as output_zip: for root, dirs, files in os.walk(input_folder): for file in files: @@ -89,14 +127,14 @@ def extract_zip(self, input_zip, unzip_folder) -> [str]: """ input_zip.extractall(unzip_folder) - # walk through and collect all files - input_files = [] + input_file_paths = [] + # Get the file paths for all the files using os.walk for root, dirs, files in os.walk(unzip_folder): for file in files: - input_files.append(os.path.join(root, file)) - return input_files + input_file_paths.append(os.path.join(root, file)) + return input_file_paths - def parse_and_calculate_quality_metric(self, input_file, algorithm_names): + def parse_and_calculate_quality_metric(self, input_file, algorithm_names, ixn_file=None): """ Parses and calculates quality metrics for a specific input file. @@ -116,12 +154,20 @@ def parse_and_calculate_quality_metric(self, input_file, algorithm_names): if not algo_name in config.algorithm_dictionary: logger.warning('Algorithm not found : ' + algo_name) else: - algo_instances.append(config.algorithm_dictionary[algo_name]()) + if algo_name != 'ixn': + algo_instances.append(config.algorithm_dictionary[algo_name]()) with open(input_file, 'r') as input_file: input_json = json.load(input_file) for feature in input_json['features']: for calculator in algo_instances: feature[calculator.qm_metric_tag()] = calculator.calculate_quality_metric(feature) + + if 'ixn' in algorithm_names: + # get the edges file from the input + + ixn_calculator = QMXNLibCalculator() + input_json = ixn_calculator.calculate_quality_metric(input_file, ixn_file) + end_time = time.time() logger.info(f"Time taken to calculate quality metrics for {input_file}: {end_time - start_time} seconds") return input_json diff --git a/src/services/servicebus_service.py b/src/services/servicebus_service.py index adadf35..6831f79 100644 --- a/src/services/servicebus_service.py +++ b/src/services/servicebus_service.py @@ -29,74 +29,90 @@ def __new__(cls): def __init__(self) -> None: self.config = Config() self.core = Core() - self.incoming_topic = self.core.get_topic(self.config.incoming_topic_name, - max_concurrent_messages=self.config.max_concurrent_messages) - self.storage_service = StorageService(core=self.core) + self.incoming_topic = self.core.get_topic(self.config.incoming_topic_name) + self.outgoing_topic = self.core.get_topic(self.config.outgoing_topic_name) + self.storage_service = StorageService(self.core) + self.listening_thread = threading.Thread(target=self.incoming_topic.subscribe, args=[self.config.incoming_topic_subscription, self.process_message]) # Start listening to the things - self.listening_thread = threading.Thread(target=self.listen) + # self.incoming_topic.subscribe(self.config.incoming_topic_subscription, self.handle_message) self.listening_thread.start() pass - - def listen(self): - self.incoming_topic.subscribe(self.config.incoming_topic_subscription, self.handle_message) - pass - def handle_message(self, msg: QueueMessage): - # Logs and creates a thread for processing - self.process_message(msg=msg) + # def handle_message(self, msg: QueueMessage): + # # Logs and creates a thread for processing + # process_thread = threading.Thread(target=self.process_message, args=[msg]) + # process_thread.start() def process_message(self, msg: QueueMessage): - logger.info(f"Processing message {msg.messageId}") - # Parse the message - quality_request = QualityRequest(messageType=msg.messageType, messageId=msg.messageId, data=msg.data) - # Download the file - input_file_url = quality_request.data.data_file - parsed_url = urlparse(input_file_url) - file_name = os.path.basename(parsed_url.path) - download_folder = os.path.join(self.config.get_download_folder(), msg.messageId) - os.makedirs(download_folder, exist_ok=True) - download_path = os.path.join(download_folder, file_name) + logger.info(f"Processing message {msg}") try: + logger.info(f"Processing message {msg.messageId}") + # Parse the message + quality_request = QualityRequest(messageType=msg.messageType,messageId=msg.messageId,data=msg.data) + # Download the file + input_file_url = quality_request.data.data_file + parsed_url = urlparse(input_file_url) + file_name = os.path.basename(parsed_url.path) + input_dir_path = parsed_url.path + download_folder = os.path.join(self.config.get_download_folder(),msg.messageId) + os.makedirs(download_folder,exist_ok=True) + download_path = os.path.join(download_folder,file_name) self.storage_service.download_remote_file(input_file_url, download_path) + logger.info(f'Downloaded file to {download_path}') + # intersection file + ixn_file_url = quality_request.data.sub_regions_file + ixn_file_path = None + if ixn_file_url is not None: + logger.info(f'Downloading intersection file {ixn_file_url}') + ixn_file_name = os.path.basename(ixn_file_url) + ixn_file_path = os.path.join(download_folder,ixn_file_name) + self.storage_service.download_remote_file(ixn_file_url, ixn_file_path) + # quality_request.data.intersectionFile = ixn_file_path + # Process the file - output_folder = os.path.join(download_folder, 'qm') - os.makedirs(output_folder, exist_ok=True) - output_file_local_path = os.path.join(output_folder, 'qm-output.zip') + output_folder = os.path.join(download_folder,'qm') + os.makedirs(output_folder,exist_ok=True) + output_file_local_path = os.path.join(output_folder,'qm-output.zip') qm_calculator = OswQmCalculator() - algorithm_names = quality_request.data.algorithms.split(',') - qm_calculator.calculate_quality_metric(download_path, algorithm_names, output_file_local_path) + algorithm_names = quality_request.data.algorithm.split(',') + qm_calculator.calculate_quality_metric(download_path, algorithm_names,output_file_local_path,ixn_file_path) # Upload the file output_file_remote_path = f'{self.get_directory_path(input_file_url)}/qm-{quality_request.data.jobId}-output.zip' - output_file_url = self.storage_service.upload_local_file(output_file_local_path, output_file_remote_path) + output_file_url = self.storage_service.upload_local_file(output_file_local_path,output_file_remote_path) logger.info(f'Uploaded file to {output_file_url}') response_data = { - 'status': 'success', - 'message': 'Quality metrics calculated successfully', - 'success': True, - 'dataset_url': input_file_url, - 'qm_dataset_url': output_file_url + 'status':'success', + 'message':'Quality metrics calculated successfully', + 'success':True, + 'dataset_url':input_file_url, + 'qm_dataset_url':output_file_url } + response = QualityMetricResponse( + messageType=msg.messageType, + messageId=msg.messageId, + data= response_data + ) + self.send_response(response) + # Process the message + # Clean up the download_folder + logger.info('Cleaning up download folder') + shutil.rmtree(download_folder) except Exception as e: - logger.error(f'Failed to process message {msg.messageId} with error {e}') + logger.error(f'Error processing message {msg.messageId} : {e}') response_data = { - 'status': 'failed', - 'message': f'Failed to process message {msg.messageId} with error {e}', - 'success': False, - 'dataset_url': input_file_url, - 'qm_dataset_url': '' + 'status':'failed', + 'message':str(e), + 'success':False, + 'dataset_url':input_file_url, + 'qm_dataset_url':None } - - response = QualityMetricResponse( - messageType=msg.messageType, - messageId=msg.messageId, - data=response_data - ) - self.send_response(msg=response) - # Process the message - # Clean up the download_folder - logger.info('Cleaning up download folder') - shutil.rmtree(download_folder) + response = QualityMetricResponse( + messageType=msg.messageType, + messageId=msg.messageId, + data= response_data + ) + self.send_response(response) pass def send_response(self, msg: QueueMessage): diff --git a/test.py b/test.py index fa048cc..29465be 100644 --- a/test.py +++ b/test.py @@ -1,29 +1,33 @@ -# Testing document for testing a simple osm input. +# # Testing document for testing a simple osm input. -from src.config import Config -from src.services.osw_qm_calculator_service import OswQmCalculator -import os -# import urllib.parse as urlparse -from urllib.parse import urlparse +# from src.config import Config +# from src.services.osw_qm_calculator_service import OswQmCalculator +# import os +# # import urllib.parse as urlparse +# from urllib.parse import urlparse -config = Config() +# config = Config() -osw_qm_calculator = OswQmCalculator() +# osw_qm_calculator = OswQmCalculator() -asset_folder = config.get_assets_folder() -download_folder = config.get_download_folder() -print(asset_folder) -print(download_folder) -test_path = os.path.join(asset_folder, 'osm-input.zip') -test_op_path = os.path.join(download_folder, 'osm-output.zip') -# osw_qm_calculator.calculate_quality_metric(test_path, ['fixed'],test_op_path) +# asset_folder = config.get_assets_folder() +# download_folder = config.get_download_folder() +# print(asset_folder) +# print(download_folder) +# test_path = os.path.join(asset_folder, 'osm-input.zip') +# test_op_path = os.path.join(download_folder, 'osm-output.zip') +# # osw_qm_calculator.calculate_quality_metric(test_path, ['fixed'],test_op_path) -# def get_directory_path(remote_url:str)-> str: -# # https://tdeisamplestorage.blob.core.windows.net/osw/test_upload/df/fff/500mb_file.zip -# # should give output test_upload/df/fff/ -# parsed_url = urlparse(remote_url) -# dirname = os.path.dirname(parsed_url.path) -# folder_path = dirname.split('/')[2:] -# folder_path = '/'.join(folder_path) -# return folder_path -# print(get_directory_path('https://tdeisamplestorage.blob.core.windows.net/osw/test_upload/df/fff/500mb_file.zip')) +# # def get_directory_path(remote_url:str)-> str: +# # # https://tdeisamplestorage.blob.core.windows.net/osw/test_upload/df/fff/500mb_file.zip +# # # should give output test_upload/df/fff/ +# # parsed_url = urlparse(remote_url) +# # dirname = os.path.dirname(parsed_url.path) +# # folder_path = dirname.split('/')[2:] +# # folder_path = '/'.join(folder_path) +# # return folder_path +# # print(get_directory_path('https://tdeisamplestorage.blob.core.windows.net/osw/test_upload/df/fff/500mb_file.zip')) +algorithms = "fixed" +algorithm_names = algorithms.split(',') +for algorithm in algorithm_names: + print(algorithm) \ No newline at end of file diff --git a/tests/xnqm/inputs/p13_edges.geojson b/tests/xnqm/inputs/p13_edges.geojson new file mode 100755 index 0000000..4f91841 --- /dev/null +++ b/tests/xnqm/inputs/p13_edges.geojson @@ -0,0 +1,3700 @@ +{ +"type": "FeatureCollection", +"name": "p13_manual", +"crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:OGC:1.3:CRS84" } }, +"features": [ +{ "type": "Feature", "properties": { "id": 1144272, "project_id": 13, "task_id": 121 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314626, 47.5991212 ], [ -122.331457, 47.5991209 ], [ -122.3312389, 47.59912 ], [ -122.3311086, 47.5991198 ], [ -122.3310486, 47.5991196 ], [ -122.3309423, 47.5991193 ], [ -122.3309389, 47.5991193 ], [ -122.3309204, 47.5991193 ], [ -122.3303852, 47.5991176 ], [ -122.3303836, 47.5991169 ] ] } }, +{ "type": "Feature", "properties": { "id": 1144274, "project_id": 13, "task_id": 105 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314626, 47.5991031 ], [ -122.3314652, 47.5990952 ], [ -122.3314429, 47.598414 ] ] } }, +{ "type": "Feature", "properties": { "id": 1144292, "project_id": 13, "task_id": 221 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314771, 47.5982101 ], [ -122.3315041, 47.5982125 ] ] } }, +{ "type": "Feature", "properties": { "id": 1151011, "project_id": 13, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331802, 47.6086451 ], [ -122.3315705, 47.6087244 ], [ -122.33078, 47.6090665 ] ] } }, +{ "type": "Feature", "properties": { "id": 1151016, "project_id": 13, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3286593, 47.6049906 ], [ -122.328123, 47.6052079 ] ] } }, +{ "type": "Feature", "properties": { "id": 1151053, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3248131, 47.6054418 ], [ -122.3250293, 47.6053597 ], [ -122.3255753, 47.6051224 ], [ -122.3257159, 47.6050568 ] ] } }, +{ "type": "Feature", "properties": { "id": 1151054, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3268017, 47.6045848 ], [ -122.3263844, 47.6047716 ], [ -122.3258866, 47.6049807 ] ] } }, +{ "type": "Feature", "properties": { "id": 1151056, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236504, 47.5959393 ], [ -122.3236481, 47.5965789 ] ] } }, +{ "type": "Feature", "properties": { "id": 1151464, "project_id": 13, "task_id": 175 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3324296, 47.6073905 ], [ -122.3329728, 47.6079502 ] ] } }, +{ "type": "Feature", "properties": { "id": 1154775, "project_id": 13, "task_id": 308 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3297447, 47.6094794 ], [ -122.3288487, 47.6098548 ] ] } }, +{ "type": "Feature", "properties": { "id": 1154956, "project_id": 13, "task_id": 23 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3382479, 47.6067307 ], [ -122.3377246, 47.6061497 ] ] } }, +{ "type": "Feature", "properties": { "id": 1154958, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3359805, 47.6058758 ], [ -122.3368169, 47.6055265 ] ] } }, +{ "type": "Feature", "properties": { "id": 1154959, "project_id": 13, "task_id": 18 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3374762, 47.6062479 ], [ -122.3366359, 47.6065908 ] ] } }, +{ "type": "Feature", "properties": { "id": 1154960, "project_id": 13, "task_id": 1 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336636, 47.6066047 ], [ -122.337167, 47.6071773 ] ] } }, +{ "type": "Feature", "properties": { "id": 1154961, "project_id": 13, "task_id": 23 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3380228, 47.6068229 ], [ -122.3375127, 47.6062526 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156106, "project_id": 13, "task_id": 259 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3322902, 47.6072387 ], [ -122.3317898, 47.6066846 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156107, "project_id": 13, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3309044, 47.6070302 ], [ -122.3317523, 47.6066774 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156108, "project_id": 13, "task_id": 419 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3309044, 47.6070302 ], [ -122.3308703, 47.6070415 ], [ -122.3312382, 47.607462 ], [ -122.3312393, 47.6074642 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159211, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182367, 47.6042857 ], [ -122.3187986, 47.6042879 ], [ -122.3193219, 47.604289 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159213, "project_id": 13, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195492, 47.6043015 ], [ -122.3199303, 47.604301 ], [ -122.320158, 47.6043025 ], [ -122.320203, 47.6043041 ], [ -122.3203143, 47.6043097 ], [ -122.3203737, 47.6043137 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159214, "project_id": 13, "task_id": 135 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3188753, 47.6028355 ], [ -122.3189737, 47.6029308 ], [ -122.3191785, 47.6031277 ], [ -122.3197141, 47.6036534 ], [ -122.320011, 47.6039466 ], [ -122.3203599, 47.6042815 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159219, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182388, 47.6051376 ], [ -122.3187948, 47.6051388 ], [ -122.3193322, 47.6051368 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159220, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182434, 47.604438 ], [ -122.3187568, 47.6044393 ], [ -122.3188356, 47.6044398 ], [ -122.3193162, 47.6044402 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159226, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182351, 47.6052617 ], [ -122.3186385, 47.6052722 ], [ -122.3187957, 47.605273 ], [ -122.3192201, 47.6052698 ], [ -122.3193336, 47.6052681 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160044, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3222066, 47.6026125 ], [ -122.3222903, 47.6025618 ], [ -122.32232, 47.6025314 ], [ -122.3223702, 47.6024633 ], [ -122.322384, 47.602427 ], [ -122.3223904, 47.602374 ], [ -122.3223779, 47.6021969 ], [ -122.3223779, 47.6021951 ], [ -122.3223474, 47.6018152 ], [ -122.3223293, 47.6017849 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160045, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209455, 47.6017954 ], [ -122.3211478, 47.6017852 ], [ -122.3211919, 47.6017853 ], [ -122.3220106, 47.6017878 ], [ -122.3223293, 47.6017849 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160046, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220418, 47.6026401 ], [ -122.3219842, 47.6026204 ], [ -122.3219633, 47.60262 ], [ -122.3218869, 47.6026186 ], [ -122.3214426, 47.602618 ], [ -122.3209014, 47.6026216 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160048, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209033, 47.6035839 ], [ -122.3208999, 47.6038751 ], [ -122.3208993, 47.6040432 ], [ -122.3209017, 47.6040851 ], [ -122.3209043, 47.6041086 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160049, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3215905, 47.6038614 ], [ -122.3215536, 47.6038763 ], [ -122.3214606, 47.603892 ], [ -122.3211323, 47.6040306 ], [ -122.3210526, 47.6040636 ], [ -122.3209056, 47.6041209 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160050, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226499, 47.6033946 ], [ -122.3220887, 47.6027814 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160051, "project_id": 13, "task_id": 283 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236686, 47.6058924 ], [ -122.3231758, 47.6053552 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160052, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3254608, 47.6061682 ], [ -122.3256843, 47.6060721 ], [ -122.3262289, 47.6058285 ], [ -122.3263367, 47.6057872 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160053, "project_id": 13, "task_id": 401 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238328, 47.6060776 ], [ -122.3241292, 47.6063964 ], [ -122.3243377, 47.6066339 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160054, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3244362, 47.606755 ], [ -122.324594, 47.6066742 ], [ -122.3251539, 47.606456 ], [ -122.3253608, 47.6063774 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160055, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249832, 47.6073526 ], [ -122.3249384, 47.6073075 ], [ -122.3247915, 47.6071484 ], [ -122.3244362, 47.606755 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160056, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3256255, 47.6080585 ], [ -122.3254117, 47.6077931 ], [ -122.3251194, 47.6074777 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160057, "project_id": 13, "task_id": 37 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3267318, 47.6075928 ], [ -122.3262322, 47.607007 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160058, "project_id": 13, "task_id": 168 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326839, 47.6075711 ], [ -122.3268401, 47.6075727 ], [ -122.3272364, 47.6074123 ], [ -122.3276258, 47.6072314 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160059, "project_id": 13, "task_id": 169 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3282978, 47.6079227 ], [ -122.3283135, 47.6079117 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160060, "project_id": 13, "task_id": 306 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3257836, 47.6081778 ], [ -122.3266579, 47.6078043 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160061, "project_id": 13, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3257756, 47.6082013 ], [ -122.3262713, 47.6087565 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160062, "project_id": 13, "task_id": 306 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3266889, 47.6078241 ], [ -122.3271812, 47.6083579 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160063, "project_id": 13, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264306, 47.6089357 ], [ -122.326945, 47.6094813 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160064, "project_id": 13, "task_id": 169 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3284315, 47.6080725 ], [ -122.3275502, 47.6084493 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160065, "project_id": 13, "task_id": 308 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3296214, 47.6093638 ], [ -122.3287334, 47.6097283 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160378, "project_id": 13, "task_id": 343 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3328625, 47.6009628 ], [ -122.3328653, 47.6009618 ], [ -122.3325332, 47.6009568 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160379, "project_id": 13, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3315799, 47.6010169 ], [ -122.331674, 47.6009602 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160380, "project_id": 13, "task_id": 431 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327501, 47.6016393 ], [ -122.3327431, 47.6016396 ], [ -122.3322306, 47.6016399 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160381, "project_id": 13, "task_id": 426 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3322842, 47.6018445 ], [ -122.3325996, 47.602201 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160382, "project_id": 13, "task_id": 427 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3335661, 47.6016497 ], [ -122.3334445, 47.6016478 ], [ -122.3330398, 47.6016413 ], [ -122.3330012, 47.6016405 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160383, "project_id": 13, "task_id": 116 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331151, 47.6010033 ], [ -122.3311681, 47.6010623 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160384, "project_id": 13, "task_id": 116 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3310766, 47.6009627 ], [ -122.3308402, 47.6009589 ], [ -122.3308397, 47.6009589 ], [ -122.3304314, 47.6009593 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160385, "project_id": 13, "task_id": 523 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301763, 47.6011845 ], [ -122.3301714, 47.6009719 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160386, "project_id": 13, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3292794, 47.6009573 ], [ -122.3294095, 47.6009567 ], [ -122.3295658, 47.6009579 ], [ -122.3295672, 47.6009579 ], [ -122.3296422, 47.6009578 ], [ -122.3296427, 47.6009578 ], [ -122.3301473, 47.6009539 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160387, "project_id": 13, "task_id": 522 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301114, 47.6017982 ], [ -122.3303162, 47.6018057 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160389, "project_id": 13, "task_id": 525 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3295799, 47.6021603 ], [ -122.3296778, 47.6020733 ], [ -122.329786, 47.602005 ], [ -122.3299611, 47.6019338 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160390, "project_id": 13, "task_id": 525 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3297217, 47.6024393 ], [ -122.3297062, 47.6024241 ], [ -122.3296964, 47.6024089 ], [ -122.3296855, 47.6023935 ], [ -122.3296656, 47.6023627 ], [ -122.329623, 47.6023072 ], [ -122.3295523, 47.602198 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160391, "project_id": 13, "task_id": 522 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3312326, 47.6027343 ], [ -122.331156, 47.6026538 ], [ -122.3308102, 47.6022719 ], [ -122.33072, 47.6021726 ], [ -122.3307197, 47.6021723 ], [ -122.3306855, 47.6021344 ], [ -122.3305331, 47.601972 ], [ -122.330468, 47.6019209 ], [ -122.3304475, 47.6019076 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160392, "project_id": 13, "task_id": 452 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3294119, 47.6025207 ], [ -122.329332, 47.6025782 ], [ -122.329262, 47.6026077 ], [ -122.3291937, 47.6026371 ], [ -122.3290388, 47.6027042 ], [ -122.3290147, 47.6027137 ], [ -122.328866, 47.6027733 ], [ -122.328628, 47.602879 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160393, "project_id": 13, "task_id": 451 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328364, 47.6029742 ], [ -122.3280103, 47.6031221 ], [ -122.3278953, 47.6031704 ], [ -122.3274742, 47.6033497 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160394, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262023, 47.6001159 ], [ -122.325692, 47.6001143 ], [ -122.3252509, 47.6001146 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160396, "project_id": 13, "task_id": 46 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3196964, 47.6015946 ], [ -122.3196912, 47.6014043 ], [ -122.3196824, 47.601371 ], [ -122.3196671, 47.6013136 ], [ -122.3195959, 47.6010866 ], [ -122.3195891, 47.6010777 ], [ -122.3195588, 47.6010553 ], [ -122.3195524, 47.6010431 ], [ -122.3195395, 47.6009964 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160397, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223176, 47.6015779 ], [ -122.3220238, 47.6015757 ], [ -122.3211405, 47.6015767 ], [ -122.3209332, 47.6015789 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160398, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319686, 47.601788 ], [ -122.320037, 47.6017858 ], [ -122.3201805, 47.6017829 ], [ -122.3204515, 47.6017865 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161082, "project_id": 13, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206192, 47.6027585 ], [ -122.32053, 47.6027598 ], [ -122.3204127, 47.6027593 ], [ -122.3197504, 47.6027547 ], [ -122.3195588, 47.6027562 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161083, "project_id": 13, "task_id": 135 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3190795, 47.6027616 ], [ -122.3192576, 47.6029359 ], [ -122.3194384, 47.6031243 ], [ -122.3197112, 47.6033708 ], [ -122.3198467, 47.6035026 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161085, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209545, 47.604591 ], [ -122.3212711, 47.6049394 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161086, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208988, 47.60514 ], [ -122.3209091, 47.6048715 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161087, "project_id": 13, "task_id": 50 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208947, 47.6052888 ], [ -122.3208875, 47.6055824 ], [ -122.3208846, 47.6056999 ], [ -122.3208841, 47.6058054 ], [ -122.3208821, 47.6059304 ], [ -122.3208834, 47.6060373 ], [ -122.3208824, 47.6060777 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161088, "project_id": 13, "task_id": 50 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3217021, 47.605765 ], [ -122.3209189, 47.6060925 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161089, "project_id": 13, "task_id": 41 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206158, 47.6051502 ], [ -122.3201014, 47.6051344 ], [ -122.3200253, 47.6051241 ], [ -122.3195232, 47.6051325 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161090, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206106, 47.6045864 ], [ -122.320615, 47.6050355 ], [ -122.3206167, 47.6051056 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161091, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206016, 47.6061365 ], [ -122.3195193, 47.6061403 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161092, "project_id": 13, "task_id": 51 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3213028, 47.606674 ], [ -122.3212891, 47.6066573 ], [ -122.3211051, 47.6064406 ], [ -122.3210627, 47.6064063 ], [ -122.3210141, 47.606435 ], [ -122.320987, 47.6064276 ], [ -122.3209374, 47.6064188 ], [ -122.3209089, 47.6064069 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161093, "project_id": 13, "task_id": 159 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214531, 47.6068469 ], [ -122.3217042, 47.6067434 ], [ -122.321744, 47.6067271 ], [ -122.3217691, 47.6067158 ], [ -122.3219508, 47.6066318 ], [ -122.3219705, 47.6066213 ], [ -122.3223027, 47.6064789 ], [ -122.3223337, 47.6064507 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161094, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320961, 47.608047 ], [ -122.3219316, 47.6076415 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161098, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3211351, 47.6081523 ], [ -122.3215842, 47.6079718 ], [ -122.3220405, 47.6077797 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164025, "project_id": 13, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3308991, 47.6008134 ], [ -122.330842, 47.6008149 ], [ -122.3304234, 47.6008111 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164026, "project_id": 13, "task_id": 119 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3313444, 47.6007974 ], [ -122.3312643, 47.6007353 ], [ -122.3309806, 47.600441 ], [ -122.3309046, 47.6003564 ], [ -122.3309045, 47.6003563 ], [ -122.3307096, 47.6001406 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164027, "project_id": 13, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314376, 47.600807 ], [ -122.3314715, 47.6001303 ], [ -122.331472, 47.6001202 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164029, "project_id": 13, "task_id": 107 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314539, 47.5999489 ], [ -122.3314626, 47.5993182 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164093, "project_id": 13, "task_id": 14 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249677, 47.5999579 ], [ -122.3249661, 47.5998226 ], [ -122.3249629, 47.5996531 ], [ -122.3249575, 47.5995508 ], [ -122.3249557, 47.599327 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164094, "project_id": 13, "task_id": 67 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323893, 47.5999571 ], [ -122.3243934, 47.599964 ], [ -122.32495, 47.599958 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164095, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249554, 47.5990614 ], [ -122.3249723, 47.5987895 ], [ -122.3249751, 47.5984516 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164096, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239243, 47.5984323 ], [ -122.3240798, 47.5984314 ], [ -122.3249529, 47.5984379 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164097, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262618, 47.5984452 ], [ -122.3262724, 47.5990797 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164098, "project_id": 13, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249763, 47.5976123 ], [ -122.3249772, 47.5982774 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164099, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323917, 47.5982801 ], [ -122.3240803, 47.5982815 ], [ -122.3249561, 47.598288 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164100, "project_id": 13, "task_id": 255 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262411, 47.5982824 ], [ -122.3251982, 47.5982855 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164101, "project_id": 13, "task_id": 80 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262614, 47.5974434 ], [ -122.3260487, 47.5974479 ], [ -122.3252613, 47.5974433 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164102, "project_id": 13, "task_id": 183 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262713, 47.5974272 ], [ -122.3262722, 47.5974083 ], [ -122.3262722, 47.5974074 ], [ -122.3262739, 47.5973018 ], [ -122.3262739, 47.5973 ], [ -122.3262754, 47.5970691 ], [ -122.3262768, 47.5968569 ], [ -122.3262851, 47.5967683 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164103, "project_id": 13, "task_id": 86 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239103, 47.5959559 ], [ -122.324097, 47.595942 ], [ -122.3244299, 47.5959479 ], [ -122.3249396, 47.5959411 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164104, "project_id": 13, "task_id": 81 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262288, 47.596609 ], [ -122.3259825, 47.5966048 ], [ -122.325845, 47.5966044 ], [ -122.3257947, 47.5966043 ], [ -122.3257254, 47.596604 ], [ -122.3252197, 47.5966025 ], [ -122.3251935, 47.5965912 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164105, "project_id": 13, "task_id": 314 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262813, 47.595952 ], [ -122.3262826, 47.5961773 ], [ -122.3262796, 47.5964374 ], [ -122.3262796, 47.5964384 ], [ -122.3262796, 47.5964386 ], [ -122.3262796, 47.5964413 ], [ -122.3262755, 47.5964706 ], [ -122.3262701, 47.5965944 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164106, "project_id": 13, "task_id": 86 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251935, 47.5965912 ], [ -122.3251781, 47.5959677 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164108, "project_id": 13, "task_id": 82 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262355, 47.5957401 ], [ -122.3260666, 47.5957411 ], [ -122.3257334, 47.5957423 ], [ -122.3254636, 47.5957338 ], [ -122.3254436, 47.5957337 ], [ -122.3254224, 47.5957337 ], [ -122.3252603, 47.5957353 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164109, "project_id": 13, "task_id": 78 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262684, 47.595713 ], [ -122.326288, 47.5956122 ], [ -122.3262881, 47.595606 ], [ -122.3262881, 47.5956034 ], [ -122.3262793, 47.5953247 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164117, "project_id": 13, "task_id": 75 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3267225, 47.5951725 ], [ -122.3270124, 47.5953285 ], [ -122.3271759, 47.595408 ], [ -122.3272324, 47.5954372 ], [ -122.3273195, 47.5954729 ], [ -122.327581, 47.595601 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166157, "project_id": 13, "task_id": 108 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340472, 47.5983826 ], [ -122.3335539, 47.5983813 ], [ -122.3334904, 47.5983485 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166158, "project_id": 13, "task_id": 107 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331709, 47.5993168 ], [ -122.3317308, 47.5994449 ], [ -122.3317364, 47.5997765 ], [ -122.3317276, 47.599957 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166159, "project_id": 13, "task_id": 377 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278456, 47.5993031 ], [ -122.3278611, 47.5993032 ], [ -122.3287195, 47.5993086 ], [ -122.3288597, 47.5993318 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166161, "project_id": 13, "task_id": 372 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328882, 47.5991007 ], [ -122.3288672, 47.5988775 ], [ -122.3288672, 47.5988767 ], [ -122.3288694, 47.5988115 ], [ -122.3288753, 47.5986162 ], [ -122.3288755, 47.5986129 ], [ -122.3288872, 47.5984814 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166162, "project_id": 13, "task_id": 374 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328855, 47.5991066 ], [ -122.3278965, 47.5991082 ], [ -122.3278296, 47.5990923 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166163, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264702, 47.5993328 ], [ -122.3264755, 47.5997319 ], [ -122.3264915, 47.5999326 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166164, "project_id": 13, "task_id": 246 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265315, 47.5999572 ], [ -122.3275147, 47.5999681 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166165, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235973, 47.5984358 ], [ -122.3234238, 47.5984358 ], [ -122.322587, 47.5984361 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166166, "project_id": 13, "task_id": 186 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225766, 47.5990718 ], [ -122.3225755, 47.599008 ], [ -122.322573, 47.5988438 ], [ -122.322573, 47.5986077 ], [ -122.3225735, 47.5984479 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166167, "project_id": 13, "task_id": 186 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223385, 47.599067 ], [ -122.3223376, 47.5990047 ], [ -122.3223373, 47.598922 ], [ -122.3223455, 47.598454 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166168, "project_id": 13, "task_id": 84 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197759, 47.5984222 ], [ -122.3223446, 47.5984299 ] ] } }, +{ "type": "Feature", "properties": { "id": 1171016, "project_id": 13, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314627, 47.6009242 ], [ -122.3314593, 47.6009237 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172019, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236589, 47.596747 ], [ -122.3233689, 47.5967464 ], [ -122.3225852, 47.5967447 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172020, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225937, 47.5974348 ], [ -122.322786, 47.5974363 ], [ -122.3234259, 47.5974412 ], [ -122.3236055, 47.5974421 ], [ -122.323605, 47.5974487 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172066, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220868, 47.605818 ], [ -122.3221354, 47.6058704 ], [ -122.3221857, 47.6059272 ], [ -122.3222176, 47.6059626 ], [ -122.3222948, 47.60605 ], [ -122.3223679, 47.606126 ], [ -122.3224558, 47.6062181 ], [ -122.3225611, 47.6063333 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172067, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223348, 47.6047037 ], [ -122.3228378, 47.6052795 ], [ -122.3228342, 47.6052931 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172069, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223258, 47.604693 ], [ -122.3219151, 47.6048752 ], [ -122.3218223, 47.6049098 ], [ -122.3214243, 47.6050723 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172070, "project_id": 13, "task_id": 369 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3276103, 47.6034876 ], [ -122.3278284, 47.6037229 ], [ -122.3281076, 47.604039 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172072, "project_id": 13, "task_id": 348 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3362305, 47.6028344 ], [ -122.3365892, 47.6026918 ], [ -122.3367613, 47.6026238 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172073, "project_id": 13, "task_id": 439 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3357098, 47.6030609 ], [ -122.3362021, 47.603599 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172074, "project_id": 13, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3366358, 47.6036585 ], [ -122.3363844, 47.6037978 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172075, "project_id": 13, "task_id": 439 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3362075, 47.6038737 ], [ -122.3361821, 47.6038849 ], [ -122.3358331, 47.6040123 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172076, "project_id": 13, "task_id": 217 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358134, 47.6040466 ], [ -122.3362602, 47.6045405 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172077, "project_id": 13, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3366838, 47.6036551 ], [ -122.3371318, 47.6041775 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172078, "project_id": 13, "task_id": 353 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3379342, 47.6038672 ], [ -122.337422, 47.6040964 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172079, "project_id": 13, "task_id": 353 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3375634, 47.6042751 ], [ -122.3380977, 47.6040498 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172080, "project_id": 13, "task_id": 353 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3372826, 47.6043531 ], [ -122.3371266, 47.6044134 ], [ -122.3370192, 47.6044992 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172081, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3370326, 47.6045154 ], [ -122.3374933, 47.6050862 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172082, "project_id": 13, "task_id": 349 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3373472, 47.6043644 ], [ -122.337859, 47.6049069 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172084, "project_id": 13, "task_id": 8 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3387165, 47.6055376 ], [ -122.3392467, 47.6053163 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172751, "project_id": 13, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3305301, 47.6089472 ], [ -122.3304595, 47.6087952 ], [ -122.3304417, 47.6087444 ], [ -122.3304221, 47.6086939 ], [ -122.3304029, 47.6086488 ], [ -122.3303821, 47.608604 ], [ -122.3303601, 47.6085595 ], [ -122.3303365, 47.6085153 ], [ -122.3303115, 47.6084714 ], [ -122.3302851, 47.608428 ], [ -122.3302089, 47.6083176 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172752, "project_id": 13, "task_id": 311 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301769, 47.6083049 ], [ -122.3293035, 47.6086726 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172753, "project_id": 13, "task_id": 308 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3293088, 47.6087142 ], [ -122.3298068, 47.6092477 ] ] } }, +{ "type": "Feature", "properties": { "id": 1173988, "project_id": 13, "task_id": 236 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288506, 47.6008109 ], [ -122.3288637, 47.6001252 ] ] } }, +{ "type": "Feature", "properties": { "id": 1173989, "project_id": 13, "task_id": 371 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278329, 47.600114 ], [ -122.3288296, 47.6001099 ] ] } }, +{ "type": "Feature", "properties": { "id": 1173991, "project_id": 13, "task_id": 456 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288291, 47.6008091 ], [ -122.3278257, 47.6008025 ] ] } }, +{ "type": "Feature", "properties": { "id": 1174070, "project_id": 13, "task_id": 19 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354699, 47.6001237 ], [ -122.3354774, 47.6001576 ], [ -122.3354687, 47.600267 ], [ -122.3354861, 47.6004372 ], [ -122.335486, 47.6004423 ], [ -122.3354872, 47.6005229 ], [ -122.3354872, 47.6005251 ], [ -122.3354927, 47.6006482 ], [ -122.335493, 47.6006519 ], [ -122.3354892, 47.6007764 ] ] } }, +{ "type": "Feature", "properties": { "id": 1174071, "project_id": 13, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317132, 47.6001364 ], [ -122.3317444, 47.6001363 ], [ -122.3339729, 47.6001263 ] ] } }, +{ "type": "Feature", "properties": { "id": 1174072, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275224, 47.6008136 ], [ -122.32704, 47.6008208 ], [ -122.3266886, 47.6008101 ], [ -122.3265243, 47.6008043 ] ] } }, +{ "type": "Feature", "properties": { "id": 1174862, "project_id": 13, "task_id": 218 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3369402, 47.6052843 ], [ -122.3364425, 47.6047375 ] ] } }, +{ "type": "Feature", "properties": { "id": 1174863, "project_id": 13, "task_id": 218 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.337339, 47.6051543 ], [ -122.336975, 47.6052897 ] ] } }, +{ "type": "Feature", "properties": { "id": 1174864, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336845, 47.6045895 ], [ -122.3373856, 47.6051212 ] ] } }, +{ "type": "Feature", "properties": { "id": 1174865, "project_id": 13, "task_id": 514 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355242, 47.6031131 ], [ -122.3351382, 47.6032701 ] ] } }, +{ "type": "Feature", "properties": { "id": 1174866, "project_id": 13, "task_id": 439 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360333, 47.6036929 ], [ -122.33601, 47.603703 ], [ -122.3358676, 47.6037811 ], [ -122.3356832, 47.6038751 ] ] } }, +{ "type": "Feature", "properties": { "id": 1174867, "project_id": 13, "task_id": 439 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355572, 47.6031331 ], [ -122.3360199, 47.6036749 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175567, "project_id": 13, "task_id": 61 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3282389, 47.6061672 ], [ -122.3273551, 47.6065682 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175568, "project_id": 13, "task_id": 61 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3273444, 47.6065935 ], [ -122.3278564, 47.607123 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175569, "project_id": 13, "task_id": 12 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3287401, 47.6067717 ], [ -122.3285995, 47.606842 ], [ -122.3284693, 47.6068958 ], [ -122.3283225, 47.6069555 ], [ -122.3283208, 47.6069562 ], [ -122.3278939, 47.6071284 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175570, "project_id": 13, "task_id": 61 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3280865, 47.6060646 ], [ -122.3272238, 47.6063965 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175571, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3248241, 47.6074187 ], [ -122.3245609, 47.6071534 ], [ -122.3244438, 47.6070232 ], [ -122.3243223, 47.6068956 ], [ -122.3242547, 47.6068229 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175572, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3242547, 47.6068229 ], [ -122.3240315, 47.6069161 ], [ -122.3238132, 47.6070131 ], [ -122.3233733, 47.6072235 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175574, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3234091, 47.6089768 ], [ -122.3232594, 47.6088025 ], [ -122.3230115, 47.6085231 ], [ -122.3228992, 47.6084066 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175575, "project_id": 13, "task_id": 287 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3234335, 47.608978 ], [ -122.3238603, 47.6087934 ], [ -122.3238985, 47.6087832 ], [ -122.3239022, 47.6087816 ], [ -122.3239093, 47.6087786 ], [ -122.324073, 47.6087095 ], [ -122.3242781, 47.6086055 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175577, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3237916, 47.6080268 ], [ -122.3235366, 47.6081413 ], [ -122.3233266, 47.6082277 ], [ -122.3232565, 47.6082589 ], [ -122.3229537, 47.6083856 ], [ -122.3229038, 47.6084046 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175578, "project_id": 13, "task_id": 500 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3342018, 47.6026818 ], [ -122.3337903, 47.6028478 ], [ -122.333358, 47.6030404 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175579, "project_id": 13, "task_id": 517 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.334864, 47.6033967 ], [ -122.3340621, 47.6037377 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175580, "project_id": 13, "task_id": 257 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3322579, 47.6034881 ], [ -122.3331215, 47.60314 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175581, "project_id": 13, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3334217, 47.6047784 ], [ -122.3329132, 47.6042327 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175582, "project_id": 13, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3318, 47.6046903 ], [ -122.3326644, 47.6043131 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175583, "project_id": 13, "task_id": 384 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3323263, 47.6052572 ], [ -122.3322294, 47.6051425 ], [ -122.332167, 47.605072 ], [ -122.3318163, 47.6047027 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175584, "project_id": 13, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3319845, 47.6036002 ], [ -122.3311647, 47.6039621 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175585, "project_id": 13, "task_id": 389 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3315436, 47.6047886 ], [ -122.3306597, 47.6051677 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175586, "project_id": 13, "task_id": 389 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3311805, 47.6057219 ], [ -122.3306597, 47.6051677 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175587, "project_id": 13, "task_id": 384 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3320654, 47.6053481 ], [ -122.3319091, 47.6051854 ], [ -122.3315914, 47.6048133 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175588, "project_id": 13, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314245, 47.6046422 ], [ -122.3313562, 47.604572 ], [ -122.3312926, 47.6045047 ], [ -122.3312246, 47.6044319 ], [ -122.3311765, 47.6043875 ], [ -122.3311546, 47.6043632 ], [ -122.3311222, 47.6043325 ], [ -122.3310816, 47.6042952 ], [ -122.3309626, 47.6041614 ], [ -122.3309082, 47.6041049 ], [ -122.3309254, 47.6040809 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175589, "project_id": 13, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3309037, 47.6040728 ], [ -122.3306441, 47.604167 ], [ -122.3304401, 47.6042589 ], [ -122.330035, 47.6044428 ], [ -122.3300197, 47.6044499 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175590, "project_id": 13, "task_id": 386 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314101, 47.6046687 ], [ -122.3305426, 47.6050168 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175591, "project_id": 13, "task_id": 124 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3304608, 47.6052383 ], [ -122.329525, 47.6056104 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175592, "project_id": 13, "task_id": 124 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3296562, 47.605744 ], [ -122.329525, 47.6056104 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175593, "project_id": 13, "task_id": 173 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3297152, 47.6058206 ], [ -122.3300228, 47.6061049 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175594, "project_id": 13, "task_id": 389 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3309795, 47.6057895 ], [ -122.3304608, 47.6052383 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175849, "project_id": 13, "task_id": 166 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3350546, 47.6052955 ], [ -122.33422, 47.6056346 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175850, "project_id": 13, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335368, 47.6069277 ], [ -122.3348672, 47.6063671 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175851, "project_id": 13, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3337609, 47.6068361 ], [ -122.334155, 47.6072482 ], [ -122.334271, 47.6073894 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175852, "project_id": 13, "task_id": 166 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3345, 47.6063093 ], [ -122.333983, 47.6057547 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175853, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333983, 47.6057547 ], [ -122.333117, 47.6061012 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175854, "project_id": 13, "task_id": 300 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3344919, 47.6063328 ], [ -122.333654, 47.6066813 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175855, "project_id": 13, "task_id": 175 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3326547, 47.6073282 ], [ -122.3331346, 47.6078631 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175856, "project_id": 13, "task_id": 130 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.334016, 47.6075138 ], [ -122.33318, 47.6078724 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175857, "project_id": 13, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3335312, 47.6069323 ], [ -122.3339252, 47.6073773 ], [ -122.3340354, 47.6074935 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175858, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3333845, 47.606778 ], [ -122.3328707, 47.6062267 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175859, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3328475, 47.60622 ], [ -122.3320043, 47.6065744 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175860, "project_id": 13, "task_id": 39 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3333652, 47.6068069 ], [ -122.3325255, 47.6071499 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175861, "project_id": 13, "task_id": 310 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3300723, 47.6081585 ], [ -122.3296018, 47.6076149 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175862, "project_id": 13, "task_id": 170 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3295391, 47.6076077 ], [ -122.3290943, 47.6077918 ], [ -122.3288512, 47.6078951 ], [ -122.3288508, 47.6078952 ], [ -122.3286941, 47.6079333 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175863, "project_id": 13, "task_id": 311 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3300643, 47.6081838 ], [ -122.3291936, 47.6085516 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175924, "project_id": 13, "task_id": 513 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355451, 47.604133 ], [ -122.3346932, 47.60448 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175925, "project_id": 13, "task_id": 408 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3351748, 47.6050125 ], [ -122.3346932, 47.60448 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175926, "project_id": 13, "task_id": 216 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355883, 47.6041388 ], [ -122.3360351, 47.6046327 ] ] } }, +{ "type": "Feature", "properties": { "id": 1176741, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182316, 47.6017772 ], [ -122.3184502, 47.6017801 ], [ -122.3189029, 47.6017791 ], [ -122.3194282, 47.6017801 ] ] } }, +{ "type": "Feature", "properties": { "id": 1177071, "project_id": 13, "task_id": 484 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3379898, 47.6028881 ], [ -122.3380129, 47.6028838 ], [ -122.3380365, 47.6028797 ], [ -122.3380888, 47.6028734 ], [ -122.3381065, 47.602872 ], [ -122.3381748, 47.602869 ], [ -122.3381843, 47.6028687 ], [ -122.3385192, 47.6028676 ], [ -122.33852, 47.6028676 ], [ -122.3386612, 47.6028676 ], [ -122.3389634, 47.6028627 ], [ -122.3389775, 47.602864 ] ] } }, +{ "type": "Feature", "properties": { "id": 1177072, "project_id": 13, "task_id": 21 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3390036, 47.6022508 ], [ -122.339002, 47.6023331 ], [ -122.339002, 47.6023332 ], [ -122.3390017, 47.602387 ], [ -122.339001, 47.602528 ], [ -122.339001, 47.6025284 ], [ -122.3390016, 47.6027808 ] ] } }, +{ "type": "Feature", "properties": { "id": 1177073, "project_id": 13, "task_id": 21 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3390036, 47.6022508 ], [ -122.3387268, 47.6022478 ], [ -122.3380236, 47.6022472 ] ] } }, +{ "type": "Feature", "properties": { "id": 1177074, "project_id": 13, "task_id": 348 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3376086, 47.6030144 ], [ -122.3374076, 47.6027788 ], [ -122.3370917, 47.6025063 ], [ -122.3370819, 47.6024947 ], [ -122.3370802, 47.6024937 ] ] } }, +{ "type": "Feature", "properties": { "id": 1177547, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3271552, 47.6046747 ], [ -122.3276325, 47.6052278 ] ] } }, +{ "type": "Feature", "properties": { "id": 1177548, "project_id": 13, "task_id": 536 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288135, 47.6047612 ], [ -122.3296888, 47.604407 ] ] } }, +{ "type": "Feature", "properties": { "id": 1177549, "project_id": 13, "task_id": 536 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291755, 47.6038313 ], [ -122.3296904, 47.6043942 ] ] } }, +{ "type": "Feature", "properties": { "id": 1177550, "project_id": 13, "task_id": 366 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291352, 47.6038241 ], [ -122.3282779, 47.6041895 ] ] } }, +{ "type": "Feature", "properties": { "id": 1177551, "project_id": 13, "task_id": 173 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3310929, 47.6059478 ], [ -122.3302913, 47.6063072 ] ] } }, +{ "type": "Feature", "properties": { "id": 1177768, "project_id": 13, "task_id": 27 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3353569, 47.5966705 ], [ -122.3353837, 47.5968728 ], [ -122.3354451, 47.5974259 ], [ -122.3354525, 47.5975356 ], [ -122.3354629, 47.597688 ], [ -122.3354632, 47.5976905 ], [ -122.3354768, 47.597823 ], [ -122.3354767, 47.597912 ], [ -122.3354748, 47.5980535 ], [ -122.3354748, 47.598061 ] ] } }, +{ "type": "Feature", "properties": { "id": 1177769, "project_id": 13, "task_id": 71 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275767, 47.5976277 ], [ -122.3275539, 47.5982814 ] ] } }, +{ "type": "Feature", "properties": { "id": 1178706, "project_id": 13, "task_id": 166 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3349183, 47.6051669 ], [ -122.3340875, 47.6054963 ] ] } }, +{ "type": "Feature", "properties": { "id": 1178707, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3324695, 47.6054081 ], [ -122.332973, 47.6059613 ] ] } }, +{ "type": "Feature", "properties": { "id": 1178708, "project_id": 13, "task_id": 391 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331331, 47.6058803 ], [ -122.3318193, 47.6064284 ] ] } }, +{ "type": "Feature", "properties": { "id": 1178709, "project_id": 13, "task_id": 12 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328931, 47.6069194 ], [ -122.3292298, 47.6072275 ], [ -122.3294144, 47.6074293 ] ] } }, +{ "type": "Feature", "properties": { "id": 1178710, "project_id": 13, "task_id": 12 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3289273, 47.6069018 ], [ -122.328931, 47.6069194 ] ] } }, +{ "type": "Feature", "properties": { "id": 1178711, "project_id": 13, "task_id": 12 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3289115, 47.6068664 ], [ -122.3285792, 47.607019 ], [ -122.3284331, 47.6070785 ], [ -122.3280106, 47.607259 ] ] } }, +{ "type": "Feature", "properties": { "id": 1178712, "project_id": 13, "task_id": 169 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3285106, 47.6078345 ], [ -122.3284678, 47.6078009 ], [ -122.3284421, 47.6077746 ], [ -122.3283155, 47.6076369 ], [ -122.3281655, 47.6074739 ], [ -122.3281442, 47.6074508 ], [ -122.3279965, 47.6072771 ] ] } }, +{ "type": "Feature", "properties": { "id": 1178714, "project_id": 13, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3255978, 47.6082642 ], [ -122.3258401, 47.6085621 ], [ -122.3258883, 47.6086142 ], [ -122.3258943, 47.6086207 ], [ -122.3260773, 47.6088109 ], [ -122.3260876, 47.6088213 ], [ -122.3260965, 47.6088303 ] ] } }, +{ "type": "Feature", "properties": { "id": 1178715, "project_id": 13, "task_id": 296 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3255461, 47.6082731 ], [ -122.3250048, 47.6084959 ], [ -122.3250047, 47.608496 ], [ -122.3246775, 47.6086272 ] ] } }, +{ "type": "Feature", "properties": { "id": 1178716, "project_id": 13, "task_id": 294 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251569, 47.6091992 ], [ -122.3246695, 47.6086507 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179591, "project_id": 13, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3363712, 47.6067161 ], [ -122.3355118, 47.6070675 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179592, "project_id": 13, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355055, 47.6070851 ], [ -122.3360189, 47.607638 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179593, "project_id": 13, "task_id": 1 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3368795, 47.6073021 ], [ -122.3360663, 47.6076532 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179594, "project_id": 13, "task_id": 199 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3352488, 47.6071703 ], [ -122.3344321, 47.6075286 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179595, "project_id": 13, "task_id": 331 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3344305, 47.607551 ], [ -122.3349273, 47.6081025 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179596, "project_id": 13, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335299, 47.6071736 ], [ -122.3357986, 47.6077425 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179597, "project_id": 13, "task_id": 130 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3341584, 47.6076394 ], [ -122.3332953, 47.6079923 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179598, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3332766, 47.6080186 ], [ -122.3337793, 47.6085614 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179599, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3346733, 47.608212 ], [ -122.3342483, 47.6083778 ], [ -122.3340661, 47.6084407 ], [ -122.3339171, 47.6085061 ], [ -122.333844, 47.6085388 ], [ -122.3337793, 47.6085614 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179739, "project_id": 13, "task_id": 429 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3316015, 47.6027994 ], [ -122.3324714, 47.6024256 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179740, "project_id": 13, "task_id": 257 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3316015, 47.6027994 ], [ -122.3321105, 47.603358 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179741, "project_id": 13, "task_id": 257 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3321531, 47.6033687 ], [ -122.3330087, 47.6030197 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179742, "project_id": 13, "task_id": 1 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3369921, 47.6074268 ], [ -122.3361743, 47.6077905 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179823, "project_id": 13, "task_id": 88 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358999, 47.6078851 ], [ -122.3350731, 47.6082305 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179824, "project_id": 13, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355996, 47.6091856 ], [ -122.3348474, 47.6083622 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179825, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3339305, 47.6087551 ], [ -122.3339545, 47.60878 ], [ -122.3346911, 47.6095443 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179865, "project_id": 13, "task_id": 536 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3293979, 47.6037337 ], [ -122.3296364, 47.6040015 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179866, "project_id": 13, "task_id": 257 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3313763, 47.6028952 ], [ -122.3318906, 47.6034594 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179867, "project_id": 13, "task_id": 505 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3313522, 47.602906 ], [ -122.3305128, 47.6032549 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179868, "project_id": 13, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3304887, 47.6032657 ], [ -122.3310122, 47.6038372 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179869, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3269445, 47.6047416 ], [ -122.3260443, 47.6051085 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179870, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265247, 47.6056941 ], [ -122.3260408, 47.6051522 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179871, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3274449, 47.6053333 ], [ -122.327343, 47.6053785 ], [ -122.3272302, 47.6054247 ], [ -122.3270062, 47.6055194 ], [ -122.3265628, 47.6057047 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179872, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236403, 47.6061431 ], [ -122.3237259, 47.6062379 ], [ -122.3240985, 47.6066501 ], [ -122.32415, 47.6067105 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179873, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236207, 47.606141 ], [ -122.323416, 47.6062255 ], [ -122.3231499, 47.6063399 ], [ -122.3229203, 47.6064327 ], [ -122.3227562, 47.6065115 ] ] } }, +{ "type": "Feature", "properties": { "id": 1181830, "project_id": 13, "task_id": 27 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3359948, 47.5980917 ], [ -122.3359855, 47.5980402 ], [ -122.3359834, 47.5978062 ], [ -122.3359832, 47.5978037 ], [ -122.3359662, 47.5976447 ], [ -122.3359661, 47.5976436 ], [ -122.3359538, 47.5975435 ], [ -122.3359375, 47.5974098 ], [ -122.3359374, 47.5974094 ], [ -122.3358846, 47.5969965 ], [ -122.3358652, 47.5966583 ] ] } }, +{ "type": "Feature", "properties": { "id": 1181987, "project_id": 13, "task_id": 204 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360232, 47.5991529 ], [ -122.336026, 47.5991027 ], [ -122.3360343, 47.59896 ], [ -122.3360329, 47.5989149 ], [ -122.3360328, 47.5989136 ], [ -122.3359932, 47.5988485 ], [ -122.3359912, 47.5984864 ], [ -122.3359907, 47.5984536 ], [ -122.3359936, 47.598418 ] ] } }, +{ "type": "Feature", "properties": { "id": 1182756, "project_id": 13, "task_id": 21 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3393199, 47.6022508 ], [ -122.3393212, 47.6023341 ], [ -122.339321, 47.6023805 ], [ -122.3393202, 47.6025286 ], [ -122.3393206, 47.6027808 ] ] } }, +{ "type": "Feature", "properties": { "id": 1184168, "project_id": 13, "task_id": 96 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3388818, 47.6044665 ], [ -122.3387776, 47.6043517 ], [ -122.3384873, 47.6040348 ], [ -122.3384059, 47.6039449 ] ] } }, +{ "type": "Feature", "properties": { "id": 1184452, "project_id": 13, "task_id": 96 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3390507, 47.604649 ], [ -122.3391802, 47.60479 ], [ -122.3394138, 47.6050463 ], [ -122.3394152, 47.6050479 ], [ -122.3395227, 47.6051627 ] ] } }, +{ "type": "Feature", "properties": { "id": 1203968, "project_id": 13, "task_id": 4 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3292034, 47.5984163 ], [ -122.3292152, 47.5976009 ], [ -122.3292319, 47.5965497 ], [ -122.3292393, 47.5961824 ], [ -122.3292451, 47.5957609 ] ] } }, +{ "type": "Feature", "properties": { "id": 1204008, "project_id": 13, "task_id": 219 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331758, 47.5982154 ], [ -122.3322368, 47.5982329 ], [ -122.3327692, 47.5982163 ], [ -122.3330431, 47.5982117 ] ] } }, +{ "type": "Feature", "properties": { "id": 1210961, "project_id": 13, "task_id": 124 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329438, 47.605897 ], [ -122.3297302, 47.606209 ], [ -122.3297534, 47.6062358 ], [ -122.3297772, 47.6062613 ], [ -122.329827, 47.6063213 ] ] } }, +{ "type": "Feature", "properties": { "id": 1210963, "project_id": 13, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3293906, 47.6054643 ], [ -122.3288781, 47.6049114 ] ] } }, +{ "type": "Feature", "properties": { "id": 1210966, "project_id": 13, "task_id": 12 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288311, 47.6066026 ], [ -122.3287153, 47.6064703 ], [ -122.3285836, 47.6063243 ], [ -122.3284683, 47.6062 ] ] } }, +{ "type": "Feature", "properties": { "id": 1210967, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327006, 47.604503 ], [ -122.3279152, 47.6041341 ] ] } }, +{ "type": "Feature", "properties": { "id": 1210968, "project_id": 13, "task_id": 369 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3274133, 47.603543 ], [ -122.3279189, 47.6040992 ] ] } }, +{ "type": "Feature", "properties": { "id": 1210969, "project_id": 13, "task_id": 124 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329379, 47.6058337 ], [ -122.3292733, 47.6057116 ] ] } }, +{ "type": "Feature", "properties": { "id": 1210970, "project_id": 13, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.32915, 47.6055706 ], [ -122.3289708, 47.6053671 ], [ -122.3289435, 47.6053368 ], [ -122.3289425, 47.6053356 ], [ -122.328825, 47.6052002 ], [ -122.3286709, 47.6050008 ] ] } }, +{ "type": "Feature", "properties": { "id": 1211019, "project_id": 13, "task_id": 84 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197819, 47.5982715 ], [ -122.3205414, 47.5982748 ], [ -122.3219495, 47.598275 ], [ -122.3223259, 47.5982769 ] ] } }, +{ "type": "Feature", "properties": { "id": 1211020, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223468, 47.5976157 ], [ -122.3223457, 47.5982631 ] ] } }, +{ "type": "Feature", "properties": { "id": 1211021, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223072, 47.5974366 ], [ -122.3223474, 47.5974366 ], [ -122.3223478, 47.5974078 ] ] } }, +{ "type": "Feature", "properties": { "id": 1211022, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3228457, 47.6033089 ], [ -122.3227554, 47.6032201 ], [ -122.3224714, 47.6029052 ], [ -122.3223608, 47.6027793 ] ] } }, +{ "type": "Feature", "properties": { "id": 1211398, "project_id": 13, "task_id": 304 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3326979, 47.6090413 ], [ -122.3321783, 47.6084806 ], [ -122.332174, 47.6084759 ] ] } }, +{ "type": "Feature", "properties": { "id": 1211399, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330537, 47.6080792 ], [ -122.3335738, 47.6086536 ] ] } }, +{ "type": "Feature", "properties": { "id": 1211400, "project_id": 13, "task_id": 413 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332174, 47.6084759 ], [ -122.3321906, 47.6084684 ], [ -122.3330323, 47.6080883 ] ] } }, +{ "type": "Feature", "properties": { "id": 1211401, "project_id": 13, "task_id": 413 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3320531, 47.6083312 ], [ -122.3320692, 47.6083251 ], [ -122.332531, 47.6081499 ], [ -122.3329369, 47.6079734 ] ] } }, +{ "type": "Feature", "properties": { "id": 1211402, "project_id": 13, "task_id": 259 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3323948, 47.6073851 ], [ -122.3315179, 47.6077647 ] ] } }, +{ "type": "Feature", "properties": { "id": 1211403, "project_id": 13, "task_id": 172 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3320099, 47.6083119 ], [ -122.3317479, 47.6080107 ], [ -122.3317178, 47.6079782 ], [ -122.3317171, 47.6079776 ], [ -122.3315179, 47.6077647 ] ] } }, +{ "type": "Feature", "properties": { "id": 1214736, "project_id": 13, "task_id": 308 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3305185, 47.6091662 ], [ -122.3304117, 47.6092084 ], [ -122.3304116, 47.6092085 ], [ -122.3302466, 47.6092748 ], [ -122.3299427, 47.6094085 ] ] } }, +{ "type": "Feature", "properties": { "id": 1214909, "project_id": 13, "task_id": 23 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3370796, 47.6054379 ], [ -122.337211, 47.6055842 ], [ -122.3376115, 47.6060241 ] ] } }, +{ "type": "Feature", "properties": { "id": 1214910, "project_id": 13, "task_id": 23 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3368517, 47.6055319 ], [ -122.33736, 47.6060901 ] ] } }, +{ "type": "Feature", "properties": { "id": 1214911, "project_id": 13, "task_id": 23 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3373493, 47.6061154 ], [ -122.3365407, 47.6064672 ] ] } }, +{ "type": "Feature", "properties": { "id": 1214912, "project_id": 13, "task_id": 1 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3379987, 47.6068337 ], [ -122.3371828, 47.6071935 ] ] } }, +{ "type": "Feature", "properties": { "id": 1216702, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206333, 47.6063367 ], [ -122.3206343, 47.6062938 ] ] } }, +{ "type": "Feature", "properties": { "id": 1219167, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193313, 47.6044417 ], [ -122.3193389, 47.6047883 ], [ -122.319332, 47.6051319 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220020, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3217482, 47.6037958 ], [ -122.3217757, 47.603783 ], [ -122.3218174, 47.6037433 ], [ -122.3221325, 47.6036106 ], [ -122.3226368, 47.6033999 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220021, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3231767, 47.6053444 ], [ -122.3233177, 47.60529 ], [ -122.3237402, 47.6051095 ], [ -122.324029, 47.6049771 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220022, "project_id": 13, "task_id": 149 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322769, 47.603535 ], [ -122.3231614, 47.6039707 ], [ -122.3238934, 47.6047664 ], [ -122.3239307, 47.6048046 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220023, "project_id": 13, "task_id": 140 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321855, 47.6039077 ], [ -122.3227593, 47.6035274 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220024, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3230356, 47.6051942 ], [ -122.3232863, 47.6050947 ], [ -122.3234904, 47.6050097 ], [ -122.3235726, 47.6049731 ], [ -122.3236782, 47.6049269 ], [ -122.323922, 47.6048299 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220025, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249433, 47.6056074 ], [ -122.325434, 47.6061665 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220027, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3263517, 47.6057614 ], [ -122.3258714, 47.6052132 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220028, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249384, 47.6055828 ], [ -122.3250925, 47.6055132 ], [ -122.3258288, 47.6051977 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220029, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238162, 47.6060484 ], [ -122.3240901, 47.605934 ], [ -122.3245075, 47.6057551 ], [ -122.3246955, 47.6056758 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220030, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252312, 47.6062623 ], [ -122.3252449, 47.6062335 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220031, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.32611, 47.6068863 ], [ -122.3259956, 47.6067455 ], [ -122.325791, 47.6065333 ], [ -122.3255831, 47.6063223 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220032, "project_id": 13, "task_id": 60 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3270257, 47.6065014 ], [ -122.3264862, 47.6059385 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220033, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325591, 47.6062987 ], [ -122.3257508, 47.6062325 ], [ -122.3263, 47.6060035 ], [ -122.3264619, 47.605932 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220034, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325001, 47.6073552 ], [ -122.3251923, 47.6072693 ], [ -122.3254283, 47.6071664 ], [ -122.3255247, 47.6071245 ], [ -122.3257429, 47.607033 ], [ -122.3257585, 47.6070277 ], [ -122.3259077, 47.6069661 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220035, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251136, 47.6074712 ], [ -122.3252512, 47.6074123 ], [ -122.3258144, 47.6071871 ], [ -122.3260305, 47.6070947 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220036, "project_id": 13, "task_id": 306 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3256579, 47.608054 ], [ -122.3265629, 47.607685 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220037, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260389, 47.607102 ], [ -122.3265495, 47.6076687 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220039, "project_id": 13, "task_id": 60 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3271407, 47.6066802 ], [ -122.3276366, 47.6072079 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220040, "project_id": 13, "task_id": 306 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327365, 47.6082886 ], [ -122.3268739, 47.6077482 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220041, "project_id": 13, "task_id": 168 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3269044, 47.6077113 ], [ -122.3273464, 47.6075356 ], [ -122.3273476, 47.6075351 ], [ -122.327779, 47.6073485 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220042, "project_id": 13, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262896, 47.6087667 ], [ -122.3271814, 47.6083996 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220043, "project_id": 13, "task_id": 58 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264348, 47.6089029 ], [ -122.3273103, 47.6085313 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220044, "project_id": 13, "task_id": 471 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3273383, 47.6085236 ], [ -122.327359, 47.6085464 ], [ -122.3278501, 47.6090873 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220045, "project_id": 13, "task_id": 169 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328963, 47.6086275 ], [ -122.328469, 47.6080797 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220347, "project_id": 13, "task_id": 438 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3349613, 47.6018273 ], [ -122.335359, 47.6018291 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220348, "project_id": 13, "task_id": 437 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358722, 47.6028025 ], [ -122.3355767, 47.6029299 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220349, "project_id": 13, "task_id": 437 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358938, 47.6027778 ], [ -122.3356309, 47.6025151 ], [ -122.335462, 47.602358 ], [ -122.3354517, 47.602344 ], [ -122.3354018, 47.6022578 ], [ -122.3353982, 47.6022506 ], [ -122.3353709, 47.6021883 ], [ -122.3353655, 47.6021669 ], [ -122.3353604, 47.6020922 ], [ -122.3353609, 47.6020795 ], [ -122.3353833, 47.6018568 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220350, "project_id": 13, "task_id": 212 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336151, 47.6018624 ], [ -122.3366192, 47.6024088 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220351, "project_id": 13, "task_id": 212 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335927, 47.6018319 ], [ -122.3356694, 47.6018311 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220352, "project_id": 13, "task_id": 97 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354967, 47.6009598 ], [ -122.3348382, 47.6009632 ], [ -122.3343974, 47.6009646 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220353, "project_id": 13, "task_id": 438 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355211, 47.6016584 ], [ -122.3349639, 47.6016484 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220354, "project_id": 13, "task_id": 435 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3348049, 47.6018281 ], [ -122.3344181, 47.6018252 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220355, "project_id": 13, "task_id": 514 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3353819, 47.6030083 ], [ -122.335031, 47.6031454 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220356, "project_id": 13, "task_id": 438 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335415, 47.6029862 ], [ -122.3348624, 47.6023742 ], [ -122.334841, 47.6023501 ], [ -122.3348236, 47.6023332 ], [ -122.3348238, 47.6018285 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220358, "project_id": 13, "task_id": 382 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3315808, 47.6011038 ], [ -122.3318755, 47.6014199 ], [ -122.3318928, 47.6014384 ], [ -122.3320905, 47.6016363 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220359, "project_id": 13, "task_id": 431 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332778, 47.6018039 ], [ -122.3325493, 47.6018017 ], [ -122.3323174, 47.6018126 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220360, "project_id": 13, "task_id": 428 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3334595, 47.6018479 ], [ -122.3325996, 47.602201 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220361, "project_id": 13, "task_id": 427 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3334235, 47.6018077 ], [ -122.3332194, 47.6018051 ], [ -122.3330592, 47.6018028 ], [ -122.3330315, 47.6018018 ], [ -122.3330154, 47.6018011 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220362, "project_id": 13, "task_id": 339 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3339712, 47.6009646 ], [ -122.3330394, 47.6009826 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220363, "project_id": 13, "task_id": 382 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330737, 47.6018184 ], [ -122.3311825, 47.6018009 ], [ -122.3314334, 47.6017967 ], [ -122.3315612, 47.6017976 ], [ -122.331588, 47.6017837 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220364, "project_id": 13, "task_id": 426 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314812, 47.6026575 ], [ -122.331633, 47.6025961 ], [ -122.3316721, 47.602579 ], [ -122.3317223, 47.6025598 ], [ -122.3317923, 47.6025321 ], [ -122.3319167, 47.6024807 ], [ -122.3323565, 47.6023014 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220365, "project_id": 13, "task_id": 382 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3313074, 47.6012213 ], [ -122.3316063, 47.601536 ], [ -122.3316233, 47.6015541 ], [ -122.3317265, 47.6016323 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220366, "project_id": 13, "task_id": 382 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3316842, 47.6016515 ], [ -122.3315846, 47.6016514 ], [ -122.3314446, 47.6016526 ], [ -122.3312076, 47.6016547 ], [ -122.3310559, 47.6016538 ], [ -122.3308686, 47.6016514 ], [ -122.3306164, 47.6016454 ], [ -122.3305535, 47.6016439 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220368, "project_id": 13, "task_id": 505 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3312331, 47.6027634 ], [ -122.3310878, 47.6028295 ], [ -122.3309948, 47.6028718 ], [ -122.3308945, 47.6029126 ], [ -122.330844, 47.6029315 ], [ -122.3307881, 47.6029545 ], [ -122.330577, 47.6030418 ], [ -122.3304727, 47.6030863 ], [ -122.3303741, 47.6031249 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220369, "project_id": 13, "task_id": 525 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3294667, 47.6025076 ], [ -122.329274, 47.6022996 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220370, "project_id": 13, "task_id": 525 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288647, 47.6009772 ], [ -122.3288529, 47.6012232 ], [ -122.3288538, 47.601394 ], [ -122.328855, 47.6015405 ], [ -122.3288554, 47.6015975 ], [ -122.3288554, 47.6016484 ], [ -122.3288564, 47.6017238 ], [ -122.3288568, 47.6017601 ], [ -122.3288582, 47.6017735 ], [ -122.3288653, 47.6018096 ], [ -122.3288744, 47.6018303 ], [ -122.3288919, 47.6018421 ], [ -122.328913, 47.6018692 ], [ -122.3289242, 47.6018802 ], [ -122.328943, 47.6018997 ], [ -122.3289675, 47.6019264 ], [ -122.328994, 47.601954 ], [ -122.3290221, 47.6019902 ], [ -122.3290402, 47.6020109 ], [ -122.329274, 47.6022996 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220371, "project_id": 13, "task_id": 456 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288238, 47.6009519 ], [ -122.3278257, 47.6009435 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220372, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265155, 47.6009515 ], [ -122.3266872, 47.6009587 ], [ -122.3275349, 47.600953 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220374, "project_id": 13, "task_id": 6 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182961, 47.5999813 ], [ -122.3183659, 47.5999808 ], [ -122.3184212, 47.5999771 ], [ -122.3184612, 47.599976 ], [ -122.3185066, 47.5999808 ], [ -122.319017, 47.6000965 ], [ -122.3191543, 47.6001298 ], [ -122.3192029, 47.600146 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220375, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3196959, 47.6016097 ], [ -122.3199784, 47.6015996 ], [ -122.3202136, 47.6016015 ], [ -122.3204468, 47.6015883 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220376, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319524, 47.6026219 ], [ -122.3195221, 47.602309 ], [ -122.3195976, 47.6022166 ], [ -122.3196156, 47.6021945 ], [ -122.3196528, 47.6021281 ], [ -122.3196706, 47.6020679 ], [ -122.3196733, 47.6020096 ], [ -122.3196707, 47.6018648 ], [ -122.3196629, 47.6017914 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220377, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206075, 47.601874 ], [ -122.3206061, 47.6021969 ], [ -122.3206148, 47.6026354 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221032, "project_id": 13, "task_id": 265 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209164, 47.6043047 ], [ -122.3209122, 47.6043418 ], [ -122.3209116, 47.6043764 ], [ -122.3209109, 47.6043939 ], [ -122.3209078, 47.6044534 ], [ -122.3209034, 47.6044831 ], [ -122.3208994, 47.6045054 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221033, "project_id": 13, "task_id": 265 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320621, 47.6041891 ], [ -122.3206355, 47.6042584 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221034, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3221983, 47.6045695 ], [ -122.3214823, 47.6048619 ], [ -122.3213199, 47.6049314 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221035, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3216598, 47.6039843 ], [ -122.3214437, 47.6040784 ], [ -122.3211879, 47.604188 ], [ -122.3209911, 47.6042727 ], [ -122.3209164, 47.6043047 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221036, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3217224, 47.6057417 ], [ -122.3211996, 47.605171 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221038, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206094, 47.6045393 ], [ -122.3205956, 47.6045133 ], [ -122.3205814, 47.6044949 ], [ -122.3205718, 47.6044859 ], [ -122.3205634, 47.604478 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221039, "project_id": 13, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195612, 47.6044282 ], [ -122.3197571, 47.6044299 ], [ -122.3200039, 47.6044318 ], [ -122.320023, 47.6044089 ], [ -122.3201279, 47.6044103 ], [ -122.3201574, 47.6044339 ], [ -122.3204186, 47.604431 ], [ -122.320456, 47.6044261 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221040, "project_id": 13, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195249, 47.604451 ], [ -122.3195103, 47.604792 ], [ -122.3195132, 47.6049066 ], [ -122.3195319, 47.6049319 ], [ -122.3195235, 47.6051148 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221042, "project_id": 13, "task_id": 50 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320627, 47.6061245 ], [ -122.3206239, 47.6055866 ], [ -122.3206179, 47.6053707 ], [ -122.3206164, 47.6052905 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221043, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208922, 47.6063017 ], [ -122.320908, 47.6062818 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221045, "project_id": 13, "task_id": 159 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218595, 47.6058976 ], [ -122.3219654, 47.6060055 ], [ -122.3220223, 47.6060674 ], [ -122.3220825, 47.606134 ], [ -122.3221233, 47.6061784 ], [ -122.322276, 47.6063535 ], [ -122.3223325, 47.6064166 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221046, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218102, 47.6058969 ], [ -122.3212611, 47.6061318 ], [ -122.3211125, 47.6061936 ], [ -122.3209632, 47.6062513 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221048, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214137, 47.6070759 ], [ -122.3219316, 47.6076415 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221049, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214047, 47.6070624 ], [ -122.32093, 47.6072626 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221050, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3212772, 47.6069188 ], [ -122.3211028, 47.6069958 ], [ -122.3209477, 47.6070615 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221051, "project_id": 13, "task_id": 51 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3212582, 47.6068973 ], [ -122.3212363, 47.6068744 ], [ -122.3210816, 47.6067127 ], [ -122.3210797, 47.6067107 ], [ -122.3209656, 47.6065846 ], [ -122.3209093, 47.6065418 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221053, "project_id": 13, "task_id": 51 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208978, 47.606556 ], [ -122.3209002, 47.6070431 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221054, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226064, 47.6083656 ], [ -122.3224888, 47.6082384 ], [ -122.3224668, 47.6082121 ], [ -122.3223179, 47.6080413 ], [ -122.3222835, 47.6080034 ], [ -122.322089, 47.6077907 ], [ -122.3220788, 47.607784 ], [ -122.3220682, 47.6077808 ] ] } }, +{ "type": "Feature", "properties": { "id": 1224009, "project_id": 13, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3292588, 47.6008093 ], [ -122.3294107, 47.6008127 ], [ -122.3295675, 47.6008139 ], [ -122.3296415, 47.6008138 ], [ -122.3301419, 47.6008111 ] ] } }, +{ "type": "Feature", "properties": { "id": 1224010, "project_id": 13, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314112, 47.6008061 ], [ -122.3314376, 47.600807 ] ] } }, +{ "type": "Feature", "properties": { "id": 1224011, "project_id": 13, "task_id": 120 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303862, 47.5992976 ], [ -122.3303875, 47.5996072 ] ] } }, +{ "type": "Feature", "properties": { "id": 1224012, "project_id": 13, "task_id": 122 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301718, 47.5992958 ], [ -122.3301808, 47.5995284 ] ] } }, +{ "type": "Feature", "properties": { "id": 1224013, "project_id": 13, "task_id": 120 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299312, 47.5992956 ], [ -122.3301664, 47.5992958 ] ] } }, +{ "type": "Feature", "properties": { "id": 1224082, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262002, 47.5999598 ], [ -122.3260182, 47.5999612 ], [ -122.3252186, 47.5999574 ] ] } }, +{ "type": "Feature", "properties": { "id": 1224083, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252107, 47.5993013 ], [ -122.3251816, 47.5993376 ] ] } }, +{ "type": "Feature", "properties": { "id": 1224084, "project_id": 13, "task_id": 250 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262728, 47.5990901 ], [ -122.3252203, 47.5990976 ] ] } }, +{ "type": "Feature", "properties": { "id": 1224085, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238834, 47.5982376 ], [ -122.3238844, 47.5979398 ], [ -122.3238852, 47.5976163 ] ] } }, +{ "type": "Feature", "properties": { "id": 1224086, "project_id": 13, "task_id": 81 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324965, 47.5967553 ], [ -122.3249652, 47.5970986 ], [ -122.3249666, 47.5974055 ], [ -122.3249667, 47.5974272 ] ] } }, +{ "type": "Feature", "properties": { "id": 1224087, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239036, 47.5967645 ], [ -122.323854, 47.5970565 ], [ -122.3238928, 47.5971265 ], [ -122.3238921, 47.5973282 ], [ -122.323893, 47.5974124 ] ] } }, +{ "type": "Feature", "properties": { "id": 1224088, "project_id": 13, "task_id": 81 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326263, 47.5967585 ], [ -122.3251866, 47.5967549 ] ] } }, +{ "type": "Feature", "properties": { "id": 1224089, "project_id": 13, "task_id": 86 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249778, 47.5959672 ], [ -122.3249702, 47.5965929 ] ] } }, +{ "type": "Feature", "properties": { "id": 1224090, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238894, 47.5965844 ], [ -122.3238944, 47.5960497 ], [ -122.3239103, 47.5959559 ] ] } }, +{ "type": "Feature", "properties": { "id": 1224091, "project_id": 13, "task_id": 82 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262813, 47.595952 ], [ -122.3262592, 47.5959512 ], [ -122.3260398, 47.5959287 ], [ -122.3255918, 47.5959506 ], [ -122.3254428, 47.5959497 ], [ -122.3254215, 47.5959496 ], [ -122.3253046, 47.5959494 ], [ -122.3251995, 47.5959471 ] ] } }, +{ "type": "Feature", "properties": { "id": 1225990, "project_id": 13, "task_id": 93 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355124, 47.5999692 ], [ -122.3355077, 47.5999642 ], [ -122.3355288, 47.5993243 ] ] } }, +{ "type": "Feature", "properties": { "id": 1225991, "project_id": 13, "task_id": 219 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317557, 47.5983745 ], [ -122.3322358, 47.5983769 ], [ -122.3327674, 47.5983785 ] ] } }, +{ "type": "Feature", "properties": { "id": 1225992, "project_id": 13, "task_id": 105 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33173, 47.5990988 ], [ -122.3317299, 47.5990731 ], [ -122.3316995, 47.5984106 ] ] } }, +{ "type": "Feature", "properties": { "id": 1225993, "project_id": 13, "task_id": 111 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3332545, 47.5983882 ], [ -122.3330759, 47.5983806 ], [ -122.3330474, 47.5983641 ] ] } }, +{ "type": "Feature", "properties": { "id": 1225994, "project_id": 13, "task_id": 71 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327815, 47.5983022 ], [ -122.3278137, 47.5982569 ], [ -122.3278149, 47.5981138 ], [ -122.3278169, 47.5978575 ], [ -122.3278174, 47.5977612 ], [ -122.3278175, 47.5977456 ], [ -122.3278065, 47.5976351 ] ] } }, +{ "type": "Feature", "properties": { "id": 1225996, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264826, 47.5984462 ], [ -122.3264774, 47.5990349 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231835, "project_id": 13, "task_id": 183 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265016, 47.5974211 ], [ -122.326511, 47.5967877 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231836, "project_id": 13, "task_id": 181 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327577, 47.596699 ], [ -122.3275775, 47.5966752 ], [ -122.32759, 47.5960215 ], [ -122.3275881, 47.5960003 ], [ -122.3275637, 47.5959735 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231837, "project_id": 13, "task_id": 78 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275184, 47.5959569 ], [ -122.3265058, 47.5959549 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231838, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225808, 47.5973964 ], [ -122.3225811, 47.5970504 ], [ -122.3225852, 47.5967447 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231883, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3229496, 47.6054207 ], [ -122.3220844, 47.6057852 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231884, "project_id": 13, "task_id": 283 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3234561, 47.6059932 ], [ -122.3230115, 47.6061769 ], [ -122.3227827, 47.6062766 ], [ -122.3226575, 47.606327 ], [ -122.322598, 47.6063381 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231885, "project_id": 13, "task_id": 283 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3234629, 47.6059797 ], [ -122.323341, 47.6058393 ], [ -122.3232829, 47.6057749 ], [ -122.3232481, 47.6057343 ], [ -122.3232023, 47.6056839 ], [ -122.3231604, 47.6056382 ], [ -122.3229842, 47.6054468 ], [ -122.3229686, 47.6054256 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231886, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219206, 47.6056566 ], [ -122.3214155, 47.6050952 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231887, "project_id": 13, "task_id": 240 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3287549, 47.6029963 ], [ -122.329554, 47.6026598 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231888, "project_id": 13, "task_id": 534 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3300941, 47.6032116 ], [ -122.3296913, 47.6033647 ], [ -122.3292612, 47.6035562 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231889, "project_id": 13, "task_id": 532 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3300837, 47.6032019 ], [ -122.3295888, 47.6026653 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231890, "project_id": 13, "task_id": 451 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3276041, 47.6034773 ], [ -122.3284939, 47.6030976 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231891, "project_id": 13, "task_id": 367 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3289959, 47.6036722 ], [ -122.3281076, 47.604039 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231892, "project_id": 13, "task_id": 348 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3372806, 47.6031245 ], [ -122.3371141, 47.6029397 ], [ -122.3368122, 47.6026076 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231893, "project_id": 13, "task_id": 217 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3366467, 47.6043998 ], [ -122.3363106, 47.6045581 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231894, "project_id": 13, "task_id": 353 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3371805, 47.6042115 ], [ -122.3368504, 47.6043148 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231895, "project_id": 13, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3369004, 47.6035806 ], [ -122.3373623, 47.6040835 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231896, "project_id": 13, "task_id": 96 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3386111, 47.6045803 ], [ -122.3386109, 47.6045796 ], [ -122.3385091, 47.6044686 ], [ -122.3382158, 47.6041485 ], [ -122.3382157, 47.6041483 ], [ -122.3381325, 47.604057 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231897, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.337847, 47.6049403 ], [ -122.337552, 47.6050731 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231898, "project_id": 13, "task_id": 8 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3381781, 47.6049747 ], [ -122.338687, 47.6055394 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231899, "project_id": 13, "task_id": 96 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3387799, 47.6047629 ], [ -122.3389084, 47.6049034 ], [ -122.3391413, 47.6051589 ], [ -122.339244, 47.6052766 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231900, "project_id": 13, "task_id": 96 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3387237, 47.6047412 ], [ -122.3387167, 47.6047424 ], [ -122.3383796, 47.6048819 ], [ -122.3381873, 47.6049599 ] ] } }, +{ "type": "Feature", "properties": { "id": 1232638, "project_id": 13, "task_id": 308 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3304621, 47.6090213 ], [ -122.3303028, 47.6090847 ], [ -122.3301378, 47.609151 ], [ -122.329881, 47.6092479 ] ] } }, +{ "type": "Feature", "properties": { "id": 1233956, "project_id": 13, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317132, 47.6001364 ], [ -122.33172, 47.6007851 ] ] } }, +{ "type": "Feature", "properties": { "id": 1233957, "project_id": 13, "task_id": 343 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3325676, 47.6008001 ], [ -122.3322287, 47.6008064 ], [ -122.3317468, 47.6008032 ] ] } }, +{ "type": "Feature", "properties": { "id": 1233958, "project_id": 13, "task_id": 246 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265335, 47.6001188 ], [ -122.3275266, 47.6001074 ], [ -122.3275381, 47.6001073 ] ] } }, +{ "type": "Feature", "properties": { "id": 1233959, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192466, 47.6008559 ], [ -122.3192419, 47.6008427 ] ] } }, +{ "type": "Feature", "properties": { "id": 1234243, "project_id": 13, "task_id": 76 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265011, 47.595717 ], [ -122.3265008, 47.5956141 ], [ -122.3265009, 47.5956078 ], [ -122.326501, 47.5956051 ], [ -122.3265123, 47.595358 ] ] } }, +{ "type": "Feature", "properties": { "id": 1234244, "project_id": 13, "task_id": 77 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3272664, 47.5957414 ], [ -122.3265253, 47.595735 ] ] } }, +{ "type": "Feature", "properties": { "id": 1234767, "project_id": 13, "task_id": 217 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3368128, 47.6045823 ], [ -122.3364555, 47.6047042 ] ] } }, +{ "type": "Feature", "properties": { "id": 1234768, "project_id": 13, "task_id": 513 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3351436, 47.6033081 ], [ -122.3352369, 47.6034077 ], [ -122.3353266, 47.6035064 ], [ -122.3353267, 47.6035065 ], [ -122.33549, 47.6036866 ], [ -122.3354901, 47.6036867 ], [ -122.3356338, 47.603846 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235522, "project_id": 13, "task_id": 12 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3287319, 47.6067345 ], [ -122.3285388, 47.6064773 ], [ -122.3284019, 47.6063993 ], [ -122.3283164, 47.6062605 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235523, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3281093, 47.606049 ], [ -122.3277712, 47.6056773 ], [ -122.3277311, 47.6056299 ], [ -122.3275732, 47.6054519 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235524, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275732, 47.6054519 ], [ -122.3272077, 47.6056014 ], [ -122.3270994, 47.6056503 ], [ -122.326912, 47.605732 ], [ -122.3266778, 47.6058356 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235525, "project_id": 13, "task_id": 60 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3271836, 47.6063911 ], [ -122.3266726, 47.6058582 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235526, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249231, 47.6075582 ], [ -122.3247861, 47.6076155 ], [ -122.3244492, 47.6077554 ], [ -122.3243883, 47.6077803 ], [ -122.3241871, 47.6078653 ], [ -122.3240111, 47.6079369 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235527, "project_id": 13, "task_id": 296 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325411, 47.6081561 ], [ -122.3248965, 47.608372 ], [ -122.324576, 47.6085192 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235528, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3254415, 47.608132 ], [ -122.3253211, 47.6079938 ], [ -122.3252037, 47.6078627 ], [ -122.3249672, 47.6076017 ], [ -122.3249388, 47.6075707 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235529, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3248043, 47.6074263 ], [ -122.3246739, 47.6074841 ], [ -122.3243297, 47.6076277 ], [ -122.324117, 47.6077154 ], [ -122.3239086, 47.6078052 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235530, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236727, 47.6079026 ], [ -122.3234096, 47.6080076 ], [ -122.3232075, 47.6080927 ], [ -122.3227784, 47.6082822 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235531, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3231375, 47.6073152 ], [ -122.3230917, 47.6073248 ], [ -122.3226733, 47.6075036 ], [ -122.3222771, 47.6076741 ], [ -122.3222505, 47.607686 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235532, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3227784, 47.6082822 ], [ -122.3226184, 47.6081087 ], [ -122.3224691, 47.6079552 ], [ -122.3222462, 47.6077074 ], [ -122.3222377, 47.607697 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235533, "project_id": 13, "task_id": 514 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.334763, 47.6032322 ], [ -122.3342486, 47.6026847 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235534, "project_id": 13, "task_id": 498 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3339026, 47.6036042 ], [ -122.333358, 47.6030404 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235535, "project_id": 13, "task_id": 517 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3347549, 47.6032575 ], [ -122.3339267, 47.6036041 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235537, "project_id": 13, "task_id": 513 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3349158, 47.6034021 ], [ -122.3350103, 47.6035021 ], [ -122.3350999, 47.6036006 ], [ -122.3352631, 47.6037806 ], [ -122.3354087, 47.6039382 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235538, "project_id": 13, "task_id": 354 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3336311, 47.6037208 ], [ -122.3331215, 47.60314 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235539, "project_id": 13, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327607, 47.6040851 ], [ -122.3322499, 47.6035116 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235540, "project_id": 13, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333627, 47.6037321 ], [ -122.3327905, 47.60409 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235541, "project_id": 13, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3337579, 47.6038578 ], [ -122.3329116, 47.604215 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235543, "project_id": 13, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3334623, 47.6047851 ], [ -122.3338801, 47.6046227 ], [ -122.3342854, 47.6044471 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235544, "project_id": 13, "task_id": 516 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3337579, 47.6038578 ], [ -122.3338417, 47.603958 ], [ -122.3338487, 47.6039656 ], [ -122.3339067, 47.6040289 ], [ -122.3342854, 47.6044471 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235545, "project_id": 13, "task_id": 385 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3332065, 47.604896 ], [ -122.3331788, 47.6049149 ], [ -122.3331454, 47.6049318 ], [ -122.3330771, 47.6049585 ], [ -122.3329399, 47.6050132 ], [ -122.332669, 47.6051232 ], [ -122.3323475, 47.6052578 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235546, "project_id": 13, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3325578, 47.6041783 ], [ -122.332022, 47.6036074 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235547, "project_id": 13, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3316563, 47.6045467 ], [ -122.3314152, 47.6042694 ], [ -122.3313467, 47.6041965 ], [ -122.3312168, 47.6040584 ], [ -122.3311633, 47.6039934 ], [ -122.3311503, 47.6039771 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235548, "project_id": 13, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3325285, 47.6042 ], [ -122.3316935, 47.6045539 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235550, "project_id": 13, "task_id": 384 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3320649, 47.6053698 ], [ -122.331656, 47.605548 ], [ -122.331226, 47.605727 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235551, "project_id": 13, "task_id": 387 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3305426, 47.6050168 ], [ -122.3305201, 47.6049892 ], [ -122.3302072, 47.6045998 ], [ -122.3301818, 47.6045724 ], [ -122.330035, 47.6044428 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235553, "project_id": 13, "task_id": 173 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3309713, 47.6058326 ], [ -122.3305306, 47.6059958 ], [ -122.330115, 47.606162 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235774, "project_id": 13, "task_id": 218 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336163, 47.6048065 ], [ -122.3367123, 47.6053783 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235775, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3353415, 47.6051901 ], [ -122.3358579, 47.6057451 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235776, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355932, 47.6058566 ], [ -122.3351777, 47.6054137 ], [ -122.3351736, 47.6054092 ], [ -122.3351714, 47.6054068 ], [ -122.3350944, 47.6053211 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235777, "project_id": 13, "task_id": 166 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3347359, 47.6062188 ], [ -122.3342135, 47.6056607 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235778, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355884, 47.6058755 ], [ -122.334759, 47.6062285 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235779, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3348626, 47.6063517 ], [ -122.3357153, 47.6059981 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235780, "project_id": 13, "task_id": 300 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3346065, 47.6064512 ], [ -122.3337672, 47.6068179 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235781, "project_id": 13, "task_id": 199 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3351435, 47.6070638 ], [ -122.3343089, 47.6073987 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235782, "project_id": 13, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3346446, 47.6064554 ], [ -122.334752, 47.6065837 ], [ -122.3351563, 47.6070321 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235783, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3336272, 47.6066752 ], [ -122.3331354, 47.6061221 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235784, "project_id": 13, "task_id": 176 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3334891, 47.6069298 ], [ -122.3326682, 47.6072713 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235786, "project_id": 13, "task_id": 260 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3325033, 47.6071441 ], [ -122.3321146, 47.6067385 ], [ -122.3320689, 47.606681 ], [ -122.3319955, 47.6065972 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235787, "project_id": 13, "task_id": 169 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291512, 47.6085401 ], [ -122.3290079, 47.6083862 ], [ -122.3289899, 47.6083667 ], [ -122.3289076, 47.6082778 ], [ -122.3288771, 47.608245 ], [ -122.3286665, 47.6079998 ], [ -122.328668, 47.6079685 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235788, "project_id": 13, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3267515, 47.6095493 ], [ -122.3265911, 47.6093713 ], [ -122.3264538, 47.6092262 ], [ -122.3264177, 47.609188 ], [ -122.3264176, 47.6091879 ], [ -122.3263496, 47.6091159 ], [ -122.326349, 47.6091153 ], [ -122.3262579, 47.6090186 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235789, "project_id": 13, "task_id": 165 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326207, 47.6089969 ], [ -122.3260129, 47.6090771 ], [ -122.3260005, 47.6090823 ], [ -122.3260002, 47.6090824 ], [ -122.3258262, 47.6091546 ], [ -122.3257877, 47.6091705 ], [ -122.3257717, 47.6091772 ], [ -122.3257643, 47.6091803 ], [ -122.3257071, 47.609204 ], [ -122.3255335, 47.6092761 ], [ -122.3255333, 47.6092762 ], [ -122.3255141, 47.6092841 ], [ -122.3253525, 47.609351 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235845, "project_id": 13, "task_id": 216 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360376, 47.604678 ], [ -122.3352178, 47.6050255 ] ] } }, +{ "type": "Feature", "properties": { "id": 1236677, "project_id": 13, "task_id": 46 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193142, 47.6010711 ], [ -122.3193273, 47.601102 ], [ -122.3194261, 47.6011526 ], [ -122.3194682, 47.6012939 ], [ -122.3194381, 47.601305 ], [ -122.3193993, 47.6013325 ], [ -122.3194216, 47.6014072 ], [ -122.3194304, 47.6014426 ], [ -122.3194359, 47.6015634 ] ] } }, +{ "type": "Feature", "properties": { "id": 1236678, "project_id": 13, "task_id": 138 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3186006, 47.6022884 ], [ -122.3189173, 47.6026037 ] ] } }, +{ "type": "Feature", "properties": { "id": 1237466, "project_id": 13, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328265, 47.6042104 ], [ -122.3283839, 47.6043488 ], [ -122.328532, 47.6045128 ], [ -122.3287655, 47.6047379 ] ] } }, +{ "type": "Feature", "properties": { "id": 1237467, "project_id": 13, "task_id": 173 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3302538, 47.6063523 ], [ -122.3307316, 47.606892 ] ] } }, +{ "type": "Feature", "properties": { "id": 1237468, "project_id": 13, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3307316, 47.606892 ], [ -122.3311659, 47.606731 ], [ -122.3315049, 47.6065889 ], [ -122.3316192, 47.6065407 ] ] } }, +{ "type": "Feature", "properties": { "id": 1237469, "project_id": 13, "task_id": 391 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3311296, 47.6059558 ], [ -122.3316237, 47.6065003 ] ] } }, +{ "type": "Feature", "properties": { "id": 1237470, "project_id": 13, "task_id": 304 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3328238, 47.6091882 ], [ -122.3328427, 47.6092083 ], [ -122.3329819, 47.6093578 ], [ -122.3329825, 47.6093584 ], [ -122.3329826, 47.6093585 ], [ -122.3329907, 47.6093672 ], [ -122.3330127, 47.6093909 ], [ -122.3332704, 47.6096686 ], [ -122.3335532, 47.6099728 ], [ -122.3335535, 47.6099731 ], [ -122.3335977, 47.6100209 ], [ -122.3335996, 47.6100247 ] ] } }, +{ "type": "Feature", "properties": { "id": 1237472, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3337049, 47.6088097 ], [ -122.3328279, 47.6091864 ], [ -122.3328238, 47.6091882 ] ] } }, +{ "type": "Feature", "properties": { "id": 1237692, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236509, 47.5976179 ], [ -122.32365, 47.5979378 ], [ -122.3236506, 47.5982316 ] ] } }, +{ "type": "Feature", "properties": { "id": 1237693, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235944, 47.5982803 ], [ -122.3227825, 47.5982801 ], [ -122.3225782, 47.5982798 ] ] } }, +{ "type": "Feature", "properties": { "id": 1238664, "project_id": 13, "task_id": 408 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3349378, 47.6051351 ], [ -122.3344941, 47.6046667 ] ] } }, +{ "type": "Feature", "properties": { "id": 1238665, "project_id": 13, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3335586, 47.6049397 ], [ -122.3344172, 47.6045756 ] ] } }, +{ "type": "Feature", "properties": { "id": 1238666, "project_id": 13, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3335586, 47.6049397 ], [ -122.3336567, 47.6050422 ], [ -122.333849, 47.6052563 ], [ -122.333975, 47.6053918 ] ] } }, +{ "type": "Feature", "properties": { "id": 1238667, "project_id": 13, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3333347, 47.6050356 ], [ -122.3334295, 47.6051358 ], [ -122.3336216, 47.6053497 ], [ -122.3337471, 47.6054926 ] ] } }, +{ "type": "Feature", "properties": { "id": 1238668, "project_id": 13, "task_id": 385 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3333133, 47.6050304 ], [ -122.3324659, 47.6053876 ] ] } }, +{ "type": "Feature", "properties": { "id": 1238669, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333864, 47.6056127 ], [ -122.3330034, 47.6059628 ] ] } }, +{ "type": "Feature", "properties": { "id": 1238670, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3322182, 47.6055135 ], [ -122.3322327, 47.6055436 ], [ -122.3322577, 47.6055808 ], [ -122.3323162, 47.6056522 ], [ -122.3324435, 47.6057839 ], [ -122.3327247, 47.6060684 ] ] } }, +{ "type": "Feature", "properties": { "id": 1238671, "project_id": 13, "task_id": 384 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3321861, 47.605508 ], [ -122.3313507, 47.6058633 ] ] } }, +{ "type": "Feature", "properties": { "id": 1238672, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327251, 47.6060857 ], [ -122.3318604, 47.6064472 ] ] } }, +{ "type": "Feature", "properties": { "id": 1238673, "project_id": 13, "task_id": 169 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3293971, 47.6074559 ], [ -122.3289548, 47.6076385 ], [ -122.3289534, 47.6076391 ], [ -122.3287098, 47.6077426 ], [ -122.3285519, 47.6078282 ] ] } }, +{ "type": "Feature", "properties": { "id": 1238674, "project_id": 13, "task_id": 165 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260801, 47.6088604 ], [ -122.3259527, 47.6089129 ], [ -122.3258728, 47.6089241 ], [ -122.3258609, 47.6089291 ], [ -122.325687, 47.6090012 ], [ -122.3256523, 47.6090156 ], [ -122.3256325, 47.6090238 ], [ -122.3256324, 47.6090239 ], [ -122.3256234, 47.6090276 ], [ -122.3255678, 47.6090507 ], [ -122.3253944, 47.6091227 ], [ -122.3253757, 47.6091304 ], [ -122.3252158, 47.6091956 ] ] } }, +{ "type": "Feature", "properties": { "id": 1238677, "project_id": 13, "task_id": 296 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324929, 47.6092932 ], [ -122.3244443, 47.6087447 ] ] } }, +{ "type": "Feature", "properties": { "id": 1238678, "project_id": 13, "task_id": 296 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235649, 47.609108 ], [ -122.3240104, 47.6089057 ], [ -122.3240149, 47.6089038 ], [ -122.324015, 47.6089037 ], [ -122.3240237, 47.6089001 ], [ -122.3241858, 47.6088315 ], [ -122.3244095, 47.6087375 ] ] } }, +{ "type": "Feature", "properties": { "id": 1239559, "project_id": 13, "task_id": 1 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3363978, 47.6067236 ], [ -122.3368876, 47.6072786 ] ] } }, +{ "type": "Feature", "properties": { "id": 1239560, "project_id": 13, "task_id": 88 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3357934, 47.6077701 ], [ -122.3356603, 47.6078165 ], [ -122.3353438, 47.6079412 ], [ -122.3353234, 47.6079497 ], [ -122.3349505, 47.6081078 ] ] } }, +{ "type": "Feature", "properties": { "id": 1239561, "project_id": 13, "task_id": 331 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3341869, 47.6076538 ], [ -122.334679, 47.6081834 ] ] } }, +{ "type": "Feature", "properties": { "id": 1239678, "project_id": 13, "task_id": 354 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3324714, 47.6024256 ], [ -122.3330087, 47.6030197 ] ] } }, +{ "type": "Feature", "properties": { "id": 1239679, "project_id": 13, "task_id": 88 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3369335, 47.6086331 ], [ -122.3367629, 47.6084457 ], [ -122.3367627, 47.6084454 ], [ -122.3364612, 47.6081197 ], [ -122.3361836, 47.6078256 ] ] } }, +{ "type": "Feature", "properties": { "id": 1239760, "project_id": 13, "task_id": 88 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3367057, 47.608727 ], [ -122.3359577, 47.6078847 ] ] } }, +{ "type": "Feature", "properties": { "id": 1239761, "project_id": 13, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358677, 47.6090717 ], [ -122.335071, 47.6082424 ] ] } }, +{ "type": "Feature", "properties": { "id": 1239763, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3347921, 47.6083454 ], [ -122.3343865, 47.6085252 ], [ -122.3341385, 47.6086302 ], [ -122.333965, 47.6087025 ], [ -122.3339215, 47.6087205 ] ] } }, +{ "type": "Feature", "properties": { "id": 1239799, "project_id": 13, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330217, 47.603376 ], [ -122.3305041, 47.6036283 ], [ -122.3307604, 47.603895 ], [ -122.3307798, 47.6039246 ], [ -122.3307859, 47.6039337 ] ] } }, +{ "type": "Feature", "properties": { "id": 1239800, "project_id": 13, "task_id": 536 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330217, 47.603376 ], [ -122.3297957, 47.6035446 ], [ -122.329406, 47.603712 ] ] } }, +{ "type": "Feature", "properties": { "id": 1239801, "project_id": 13, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3307859, 47.6039337 ], [ -122.3307641, 47.6039534 ], [ -122.3306305, 47.6040132 ], [ -122.3299133, 47.6043084 ] ] } }, +{ "type": "Feature", "properties": { "id": 1239802, "project_id": 13, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3318795, 47.6034871 ], [ -122.3310423, 47.6038418 ] ] } }, +{ "type": "Feature", "properties": { "id": 1239803, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327788, 47.6053488 ], [ -122.3277987, 47.6053434 ] ] } }, +{ "type": "Feature", "properties": { "id": 1239804, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3269628, 47.6047475 ], [ -122.3274476, 47.6052982 ] ] } }, +{ "type": "Feature", "properties": { "id": 1239805, "project_id": 13, "task_id": 159 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321599, 47.6069692 ], [ -122.322474, 47.6066287 ] ] } }, +{ "type": "Feature", "properties": { "id": 1239806, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3215687, 47.6069821 ], [ -122.3220995, 47.6075722 ] ] } }, +{ "type": "Feature", "properties": { "id": 1240451, "project_id": 13, "task_id": 22 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3390062, 47.6020357 ], [ -122.3387292, 47.6020318 ], [ -122.3387276, 47.6020318 ], [ -122.3380316, 47.6020538 ] ] } }, +{ "type": "Feature", "properties": { "id": 1240649, "project_id": 13, "task_id": 27 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3357941, 47.5980456 ], [ -122.3357959, 47.5979135 ], [ -122.3357959, 47.5979126 ], [ -122.335796, 47.5978194 ], [ -122.3357956, 47.5978118 ], [ -122.3357818, 47.5976768 ], [ -122.3357715, 47.5975257 ], [ -122.335764, 47.5974145 ], [ -122.3357637, 47.5974113 ], [ -122.335702, 47.5968559 ], [ -122.3357018, 47.5968545 ], [ -122.3356769, 47.5966642 ] ] } }, +{ "type": "Feature", "properties": { "id": 1243683, "project_id": 13, "task_id": 484 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3380483, 47.6031108 ], [ -122.3380831, 47.6030958 ], [ -122.3381045, 47.6030908 ], [ -122.338136, 47.6030871 ], [ -122.3381907, 47.6030847 ], [ -122.3385204, 47.6030836 ], [ -122.3386631, 47.6030836 ], [ -122.3386669, 47.6030835 ], [ -122.3389768, 47.6030785 ], [ -122.3389855, 47.603079 ] ] } }, +{ "type": "Feature", "properties": { "id": 1243968, "project_id": 13, "task_id": 486 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.337763, 47.6032384 ], [ -122.3382026, 47.6037192 ], [ -122.3382228, 47.6037414 ], [ -122.3382263, 47.6037425 ] ] } }, +{ "type": "Feature", "properties": { "id": 1264092, "project_id": 13, "task_id": 414 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3321573, 47.6084903 ], [ -122.3320354, 47.60857 ] ] } }, +{ "type": "Feature", "properties": { "id": 1264093, "project_id": 13, "task_id": 414 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3320879, 47.608342 ], [ -122.3321836, 47.6084532 ] ] } }, +{ "type": "Feature", "properties": { "id": 1275096, "project_id": 13, "task_id": 23 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3377056, 47.6061473 ], [ -122.3375315, 47.606239 ] ] } }, +{ "type": "Feature", "properties": { "id": 1275097, "project_id": 13, "task_id": 23 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.337477, 47.6062342 ], [ -122.3373888, 47.6061118 ] ] } }, +{ "type": "Feature", "properties": { "id": 1275098, "project_id": 13, "task_id": 23 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3373888, 47.6061118 ], [ -122.3375978, 47.6060309 ] ] } }, +{ "type": "Feature", "properties": { "id": 1275099, "project_id": 13, "task_id": 23 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3373493, 47.6061154 ], [ -122.33736, 47.6060901 ] ] } }, +{ "type": "Feature", "properties": { "id": 1275100, "project_id": 13, "task_id": 23 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3373888, 47.6061118 ], [ -122.33736, 47.6060901 ] ] } }, +{ "type": "Feature", "properties": { "id": 1275101, "project_id": 13, "task_id": 23 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3373888, 47.6061118 ], [ -122.3373493, 47.6061154 ] ] } }, +{ "type": "Feature", "properties": { "id": 1275102, "project_id": 13, "task_id": 23 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3376115, 47.6060241 ], [ -122.3377246, 47.6061497 ] ] } }, +{ "type": "Feature", "properties": { "id": 1275103, "project_id": 13, "task_id": 23 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3377056, 47.6061473 ], [ -122.3377246, 47.6061497 ] ] } }, +{ "type": "Feature", "properties": { "id": 1275104, "project_id": 13, "task_id": 23 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3375978, 47.6060309 ], [ -122.3376115, 47.6060241 ] ] } }, +{ "type": "Feature", "properties": { "id": 1275105, "project_id": 13, "task_id": 23 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3375127, 47.6062526 ], [ -122.3374762, 47.6062479 ] ] } }, +{ "type": "Feature", "properties": { "id": 1275106, "project_id": 13, "task_id": 23 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.337477, 47.6062342 ], [ -122.3374762, 47.6062479 ] ] } }, +{ "type": "Feature", "properties": { "id": 1275107, "project_id": 13, "task_id": 23 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3375315, 47.606239 ], [ -122.3375127, 47.6062526 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291257, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223003, 47.6027316 ], [ -122.322119, 47.6027696 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291258, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322047, 47.6027446 ], [ -122.3220387, 47.6026657 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291259, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322217, 47.6026298 ], [ -122.3223003, 47.6027316 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291260, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220418, 47.6026401 ], [ -122.3220884, 47.6026545 ], [ -122.3222066, 47.6026125 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291261, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322217, 47.6026298 ], [ -122.3222066, 47.6026125 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291262, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220387, 47.6026657 ], [ -122.3220418, 47.6026401 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291263, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223228, 47.602739 ], [ -122.3223608, 47.6027793 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291265, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223003, 47.6027316 ], [ -122.3223228, 47.602739 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291266, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220887, 47.6027814 ], [ -122.3220435, 47.6027762 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291267, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322047, 47.6027446 ], [ -122.3220435, 47.6027762 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291268, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322119, 47.6027696 ], [ -122.3220887, 47.6027814 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291269, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240296, 47.6049575 ], [ -122.3239658, 47.6048428 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291270, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3247764, 47.6054414 ], [ -122.3249109, 47.6055935 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291271, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249109, 47.6055935 ], [ -122.324768, 47.605676 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291272, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324684, 47.6056641 ], [ -122.3245597, 47.6055717 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291273, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3245937, 47.6055134 ], [ -122.3247764, 47.6054414 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291274, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.32454, 47.6055552 ], [ -122.3245623, 47.6055161 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291275, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3245937, 47.6055134 ], [ -122.3245623, 47.6055161 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291276, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3245597, 47.6055717 ], [ -122.32454, 47.6055552 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291277, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3247811, 47.6054292 ], [ -122.3248131, 47.6054418 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291278, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3247764, 47.6054414 ], [ -122.3248131, 47.6054418 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291279, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3247764, 47.6054414 ], [ -122.3247811, 47.6054292 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291280, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249384, 47.6055828 ], [ -122.3249433, 47.6056074 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291281, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249109, 47.6055935 ], [ -122.3249433, 47.6056074 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291282, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249109, 47.6055935 ], [ -122.3249384, 47.6055828 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291283, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3247469, 47.6056844 ], [ -122.3246955, 47.6056758 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291284, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324684, 47.6056641 ], [ -122.3246955, 47.6056758 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291285, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324768, 47.605676 ], [ -122.3247469, 47.6056844 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291286, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3254742, 47.6061863 ], [ -122.3255547, 47.6062758 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291287, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3255359, 47.6063239 ], [ -122.3254131, 47.6063819 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291288, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3253617, 47.6063647 ], [ -122.3252742, 47.6062714 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291289, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252782, 47.6062372 ], [ -122.325425, 47.6061796 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291290, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252782, 47.6062372 ], [ -122.3252449, 47.6062335 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291291, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252742, 47.6062714 ], [ -122.3252312, 47.6062623 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291292, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325434, 47.6061665 ], [ -122.3254608, 47.6061682 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291293, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3254742, 47.6061863 ], [ -122.3254608, 47.6061682 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291294, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325425, 47.6061796 ], [ -122.325434, 47.6061665 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291295, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325591, 47.6062987 ], [ -122.3255831, 47.6063223 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291296, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3255359, 47.6063239 ], [ -122.3255831, 47.6063223 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291297, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3255547, 47.6062758 ], [ -122.325591, 47.6062987 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291298, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3253958, 47.6063898 ], [ -122.3253608, 47.6063774 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291299, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3253617, 47.6063647 ], [ -122.3253608, 47.6063774 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291300, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3254131, 47.6063819 ], [ -122.3253958, 47.6063898 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291301, "project_id": 13, "task_id": 37 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3261519, 47.606907 ], [ -122.3262107, 47.6069785 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291302, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262035, 47.6070157 ], [ -122.3260546, 47.6070907 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291303, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260173, 47.6070788 ], [ -122.3259282, 47.6069875 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291304, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3259454, 47.606955 ], [ -122.3260732, 47.6069016 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291305, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3259077, 47.6069661 ], [ -122.3259284, 47.6069606 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291306, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3259454, 47.606955 ], [ -122.3259284, 47.6069606 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291307, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3259282, 47.6069875 ], [ -122.3259077, 47.6069661 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291308, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.32611, 47.6068863 ], [ -122.3261332, 47.6068812 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291309, "project_id": 13, "task_id": 37 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3261519, 47.606907 ], [ -122.3261332, 47.6068812 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291310, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260732, 47.6069016 ], [ -122.32611, 47.6068863 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291311, "project_id": 13, "task_id": 37 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262207, 47.6069913 ], [ -122.3262322, 47.607007 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291312, "project_id": 13, "task_id": 37 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262035, 47.6070157 ], [ -122.3262322, 47.607007 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291313, "project_id": 13, "task_id": 37 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262107, 47.6069785 ], [ -122.3262207, 47.6069913 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291314, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260389, 47.607102 ], [ -122.3260305, 47.6070947 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291315, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260173, 47.6070788 ], [ -122.3260305, 47.6070947 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291316, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260546, 47.6070907 ], [ -122.3260389, 47.607102 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291317, "project_id": 13, "task_id": 306 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3267822, 47.6076192 ], [ -122.3268581, 47.6077053 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291318, "project_id": 13, "task_id": 306 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3268581, 47.6077053 ], [ -122.3266831, 47.6077881 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291319, "project_id": 13, "task_id": 306 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3266831, 47.6077881 ], [ -122.3265881, 47.6077067 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291320, "project_id": 13, "task_id": 306 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3266006, 47.6076536 ], [ -122.326718, 47.6075982 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291321, "project_id": 13, "task_id": 306 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265629, 47.607685 ], [ -122.3265495, 47.6076687 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291322, "project_id": 13, "task_id": 306 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3266006, 47.6076536 ], [ -122.3265495, 47.6076687 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291323, "project_id": 13, "task_id": 306 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265881, 47.6077067 ], [ -122.3265629, 47.607685 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291324, "project_id": 13, "task_id": 306 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3267318, 47.6075928 ], [ -122.326839, 47.6075711 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291325, "project_id": 13, "task_id": 306 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3267822, 47.6076192 ], [ -122.326839, 47.6075711 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291326, "project_id": 13, "task_id": 306 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326718, 47.6075982 ], [ -122.3267318, 47.6075928 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291327, "project_id": 13, "task_id": 306 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3269044, 47.6077113 ], [ -122.3268739, 47.6077482 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291328, "project_id": 13, "task_id": 306 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3268581, 47.6077053 ], [ -122.3268739, 47.6077482 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291329, "project_id": 13, "task_id": 306 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3268581, 47.6077053 ], [ -122.3269044, 47.6077113 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291330, "project_id": 13, "task_id": 306 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3266889, 47.6078241 ], [ -122.3266579, 47.6078043 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291331, "project_id": 13, "task_id": 306 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3266831, 47.6077881 ], [ -122.3266579, 47.6078043 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291332, "project_id": 13, "task_id": 306 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3266831, 47.6077881 ], [ -122.3266889, 47.6078241 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291333, "project_id": 13, "task_id": 473 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3274208, 47.6083064 ], [ -122.3275299, 47.6084423 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291334, "project_id": 13, "task_id": 473 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275243, 47.6084708 ], [ -122.3273855, 47.6085361 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291335, "project_id": 13, "task_id": 473 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3273017, 47.6085169 ], [ -122.3272116, 47.608388 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291336, "project_id": 13, "task_id": 473 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3272166, 47.6083526 ], [ -122.3273543, 47.6082922 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291337, "project_id": 13, "task_id": 473 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3271814, 47.6083996 ], [ -122.3271812, 47.6083579 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291338, "project_id": 13, "task_id": 473 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3272166, 47.6083526 ], [ -122.3271812, 47.6083579 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291339, "project_id": 13, "task_id": 473 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3272116, 47.608388 ], [ -122.3271814, 47.6083996 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291340, "project_id": 13, "task_id": 473 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327365, 47.6082886 ], [ -122.3273915, 47.6082953 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291342, "project_id": 13, "task_id": 473 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3273543, 47.6082922 ], [ -122.327365, 47.6082886 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291343, "project_id": 13, "task_id": 473 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275502, 47.6084493 ], [ -122.3275422, 47.6084679 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291344, "project_id": 13, "task_id": 473 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275243, 47.6084708 ], [ -122.3275422, 47.6084679 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291345, "project_id": 13, "task_id": 473 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275299, 47.6084423 ], [ -122.3275502, 47.6084493 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291346, "project_id": 13, "task_id": 473 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3273383, 47.6085236 ], [ -122.3273103, 47.6085313 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291347, "project_id": 13, "task_id": 473 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3273017, 47.6085169 ], [ -122.3273103, 47.6085313 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292670, "project_id": 13, "task_id": 440 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3356631, 47.6016535 ], [ -122.3356223, 47.6018113 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292671, "project_id": 13, "task_id": 440 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355722, 47.6018654 ], [ -122.3354072, 47.6018307 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292673, "project_id": 13, "task_id": 440 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3353833, 47.6018568 ], [ -122.335359, 47.6018291 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292674, "project_id": 13, "task_id": 440 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354072, 47.6018307 ], [ -122.335359, 47.6018291 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292675, "project_id": 13, "task_id": 440 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354072, 47.6018307 ], [ -122.3353833, 47.6018568 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292677, "project_id": 13, "task_id": 440 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3356631, 47.6016535 ], [ -122.3356996, 47.6016554 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292679, "project_id": 13, "task_id": 440 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3356694, 47.6018311 ], [ -122.3356004, 47.6018803 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292680, "project_id": 13, "task_id": 440 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355722, 47.6018654 ], [ -122.3356004, 47.6018803 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292681, "project_id": 13, "task_id": 440 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3356223, 47.6018113 ], [ -122.3356694, 47.6018311 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292683, "project_id": 13, "task_id": 438 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3349481, 47.6018217 ], [ -122.3348344, 47.6018215 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292685, "project_id": 13, "task_id": 438 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3348238, 47.6018285 ], [ -122.3348049, 47.6018281 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292687, "project_id": 13, "task_id": 438 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3348344, 47.6018215 ], [ -122.3348238, 47.6018285 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292688, "project_id": 13, "task_id": 438 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3347254, 47.6016484 ], [ -122.3349639, 47.6016484 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292693, "project_id": 13, "task_id": 438 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3349481, 47.6018217 ], [ -122.3349613, 47.6018273 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292694, "project_id": 13, "task_id": 427 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330797, 47.601665 ], [ -122.3330317, 47.6017818 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292695, "project_id": 13, "task_id": 427 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327599, 47.6017835 ], [ -122.332744, 47.601663 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292696, "project_id": 13, "task_id": 427 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33277, 47.6016387 ], [ -122.332961, 47.6016405 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292697, "project_id": 13, "task_id": 427 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3329744, 47.6016405 ], [ -122.3330012, 47.6016405 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292698, "project_id": 13, "task_id": 427 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330797, 47.601665 ], [ -122.3330012, 47.6016405 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292699, "project_id": 13, "task_id": 427 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332961, 47.6016405 ], [ -122.3329744, 47.6016405 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292700, "project_id": 13, "task_id": 427 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330154, 47.6018011 ], [ -122.332778, 47.6018039 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292701, "project_id": 13, "task_id": 427 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327599, 47.6017835 ], [ -122.332778, 47.6018039 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292703, "project_id": 13, "task_id": 431 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3321163, 47.6016629 ], [ -122.332276, 47.6017986 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292704, "project_id": 13, "task_id": 382 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332252, 47.6018246 ], [ -122.331914, 47.6017851 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292705, "project_id": 13, "task_id": 382 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331914, 47.6017851 ], [ -122.3317508, 47.601662 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292706, "project_id": 13, "task_id": 382 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331773, 47.6016413 ], [ -122.3320626, 47.6016505 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292707, "project_id": 13, "task_id": 382 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3316842, 47.6016515 ], [ -122.3317265, 47.6016323 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292708, "project_id": 13, "task_id": 382 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331773, 47.6016413 ], [ -122.3317265, 47.6016323 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292709, "project_id": 13, "task_id": 382 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317508, 47.601662 ], [ -122.3316842, 47.6016515 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292710, "project_id": 13, "task_id": 382 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3320905, 47.6016363 ], [ -122.3322306, 47.6016399 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292711, "project_id": 13, "task_id": 431 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3321163, 47.6016629 ], [ -122.3322306, 47.6016399 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292712, "project_id": 13, "task_id": 382 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3320626, 47.6016505 ], [ -122.3320905, 47.6016363 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292713, "project_id": 13, "task_id": 431 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3323174, 47.6018126 ], [ -122.3322842, 47.6018445 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292714, "project_id": 13, "task_id": 431 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332252, 47.6018246 ], [ -122.3322842, 47.6018445 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292715, "project_id": 13, "task_id": 431 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332276, 47.6017986 ], [ -122.3323174, 47.6018126 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292716, "project_id": 13, "task_id": 382 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3318933, 47.601795 ], [ -122.331588, 47.6017837 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292718, "project_id": 13, "task_id": 382 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331914, 47.6017851 ], [ -122.3318933, 47.601795 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292720, "project_id": 13, "task_id": 508 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330617, 47.6016538 ], [ -122.3307202, 47.6018193 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292721, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322316, 47.6017533 ], [ -122.322316, 47.6016028 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292722, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208296, 47.6018099 ], [ -122.3206799, 47.6018531 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292723, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3204438, 47.6017338 ], [ -122.320444, 47.6016445 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292724, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209384, 47.6016525 ], [ -122.3209396, 47.6017366 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292725, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3204468, 47.6015883 ], [ -122.3208451, 47.6015806 ], [ -122.3209332, 47.6015789 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292726, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209384, 47.6016525 ], [ -122.3209332, 47.6015789 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292727, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320444, 47.6016445 ], [ -122.3204468, 47.6015883 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292728, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209455, 47.6017954 ], [ -122.320892, 47.6018026 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292729, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208296, 47.6018099 ], [ -122.320892, 47.6018026 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292730, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209396, 47.6017366 ], [ -122.3209455, 47.6017954 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292731, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206075, 47.601874 ], [ -122.3205793, 47.6018289 ], [ -122.3204515, 47.6017865 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292732, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3204438, 47.6017338 ], [ -122.3204515, 47.6017865 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292733, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206799, 47.6018531 ], [ -122.3206075, 47.601874 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295860, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320848, 47.6026416 ], [ -122.3208609, 47.60276 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295861, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208609, 47.60276 ], [ -122.320647, 47.6027558 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295862, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3205969, 47.6027326 ], [ -122.320588, 47.6026639 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295863, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320646, 47.6026358 ], [ -122.320848, 47.6026416 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295864, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3205895, 47.6026468 ], [ -122.3206148, 47.6026354 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295865, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320646, 47.6026358 ], [ -122.3206148, 47.6026354 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295866, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320588, 47.6026639 ], [ -122.3205895, 47.6026468 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295868, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320848, 47.6026416 ], [ -122.3209014, 47.6026216 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295869, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320848, 47.6026416 ], [ -122.3209014, 47.6026216 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295871, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208609, 47.60276 ], [ -122.3209031, 47.6027754 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295872, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208609, 47.60276 ], [ -122.3209031, 47.6027754 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295874, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3205969, 47.6027326 ], [ -122.3206192, 47.6027585 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295875, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320647, 47.6027558 ], [ -122.3206192, 47.6027585 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295878, "project_id": 13, "task_id": 265 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209076, 47.6041476 ], [ -122.320911, 47.6042792 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295879, "project_id": 13, "task_id": 265 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209043, 47.6041086 ], [ -122.3209056, 47.6041209 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295880, "project_id": 13, "task_id": 265 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209076, 47.6041476 ], [ -122.3209056, 47.6041209 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295884, "project_id": 13, "task_id": 265 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320911, 47.6042792 ], [ -122.3209164, 47.6043047 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295888, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320938, 47.6046039 ], [ -122.3208949, 47.6048453 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295889, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208949, 47.6048453 ], [ -122.32065, 47.6046003 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295890, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206263, 47.6045287 ], [ -122.3206425, 47.6042773 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295891, "project_id": 13, "task_id": 265 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206425, 47.6042773 ], [ -122.3208729, 47.6044789 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295892, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206238, 47.6042632 ], [ -122.3206355, 47.6042584 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295893, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206425, 47.6042773 ], [ -122.3206355, 47.6042584 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295894, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206425, 47.6042773 ], [ -122.3206238, 47.6042632 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295895, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208994, 47.6045054 ], [ -122.3209545, 47.604591 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295896, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320938, 47.6046039 ], [ -122.3209545, 47.604591 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295897, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208729, 47.6044789 ], [ -122.3208994, 47.6045054 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295898, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206106, 47.6045864 ], [ -122.3206094, 47.6045393 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295899, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206263, 47.6045287 ], [ -122.3206094, 47.6045393 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295900, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.32065, 47.6046003 ], [ -122.3206106, 47.6045864 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295901, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208476, 47.6052899 ], [ -122.3206602, 47.6052868 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295902, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206034, 47.6052483 ], [ -122.320604, 47.6051686 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295904, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206158, 47.6051502 ], [ -122.3206167, 47.6051056 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295906, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320604, 47.6051686 ], [ -122.3206158, 47.6051502 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295907, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208988, 47.60514 ], [ -122.3208947, 47.6052888 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295908, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208476, 47.6052899 ], [ -122.3208947, 47.6052888 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295910, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206164, 47.6052905 ], [ -122.3206162, 47.6052754 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295911, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206034, 47.6052483 ], [ -122.3206162, 47.6052754 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295912, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206602, 47.6052868 ], [ -122.3206164, 47.6052905 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295913, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320654, 47.6061365 ], [ -122.3208581, 47.606092 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295914, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209084, 47.6061094 ], [ -122.3209425, 47.6062302 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295915, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208687, 47.6062813 ], [ -122.3206538, 47.6063085 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295916, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320599, 47.6062589 ], [ -122.3206064, 47.606155 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295917, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206343, 47.6062938 ], [ -122.3205982, 47.6062892 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295918, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320599, 47.6062589 ], [ -122.3205982, 47.6062892 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295919, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206538, 47.6063085 ], [ -122.3206343, 47.6062938 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295920, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206016, 47.6061365 ], [ -122.320627, 47.6061245 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295921, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320654, 47.6061365 ], [ -122.320627, 47.6061245 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295922, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206064, 47.606155 ], [ -122.3206016, 47.6061365 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295923, "project_id": 13, "task_id": 50 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208824, 47.6060777 ], [ -122.3209189, 47.6060925 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295924, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209084, 47.6061094 ], [ -122.3209189, 47.6060925 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295925, "project_id": 13, "task_id": 50 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208581, 47.606092 ], [ -122.3208824, 47.6060777 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295926, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209632, 47.6062513 ], [ -122.320908, 47.6062818 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295927, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208687, 47.6062813 ], [ -122.320908, 47.6062818 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295928, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209425, 47.6062302 ], [ -122.3209632, 47.6062513 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295930, "project_id": 13, "task_id": 163 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209239, 47.607089 ], [ -122.320927, 47.6072364 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311053, "project_id": 13, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330388, 47.6008209 ], [ -122.3303874, 47.6009499 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311054, "project_id": 13, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303874, 47.6009499 ], [ -122.3301903, 47.6009523 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311055, "project_id": 13, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301903, 47.6009523 ], [ -122.3301809, 47.6008198 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311056, "project_id": 13, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301809, 47.6008198 ], [ -122.330388, 47.6008209 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311057, "project_id": 13, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301419, 47.6008111 ], [ -122.3301744, 47.6008103 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311058, "project_id": 13, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301809, 47.6008198 ], [ -122.3301744, 47.6008103 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311059, "project_id": 13, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301809, 47.6008198 ], [ -122.3301419, 47.6008111 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311060, "project_id": 13, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303921, 47.600811 ], [ -122.3304234, 47.6008111 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311061, "project_id": 13, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330388, 47.6008209 ], [ -122.3304234, 47.6008111 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311062, "project_id": 13, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330388, 47.6008209 ], [ -122.3303921, 47.600811 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311063, "project_id": 13, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3304314, 47.6009593 ], [ -122.3303838, 47.6009713 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311064, "project_id": 13, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303874, 47.6009499 ], [ -122.3303838, 47.6009713 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311065, "project_id": 13, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303874, 47.6009499 ], [ -122.3304314, 47.6009593 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311066, "project_id": 13, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301714, 47.6009719 ], [ -122.3301473, 47.6009539 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311067, "project_id": 13, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301903, 47.6009523 ], [ -122.3301473, 47.6009539 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311068, "project_id": 13, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301903, 47.6009523 ], [ -122.3301714, 47.6009719 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311071, "project_id": 13, "task_id": 122 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299789, 47.5996812 ], [ -122.3301367, 47.5995738 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311072, "project_id": 13, "task_id": 122 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301898, 47.5995494 ], [ -122.330374, 47.5996036 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311073, "project_id": 13, "task_id": 235 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303875, 47.5996072 ], [ -122.3303999, 47.5998069 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311075, "project_id": 13, "task_id": 235 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330374, 47.5996036 ], [ -122.3303875, 47.5996072 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311076, "project_id": 13, "task_id": 122 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330204, 47.5999425 ], [ -122.3299689, 47.5997065 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311077, "project_id": 13, "task_id": 122 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299789, 47.5996812 ], [ -122.3299689, 47.5997065 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311079, "project_id": 13, "task_id": 120 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303401, 47.5992944 ], [ -122.3302414, 47.5992866 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311081, "project_id": 13, "task_id": 120 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303706, 47.5991443 ], [ -122.3303924, 47.5992659 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311082, "project_id": 13, "task_id": 120 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299837, 47.5991052 ], [ -122.3303836, 47.5991169 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311083, "project_id": 13, "task_id": 120 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303706, 47.5991443 ], [ -122.3303836, 47.5991169 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311086, "project_id": 13, "task_id": 120 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303401, 47.5992944 ], [ -122.3303862, 47.5992976 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311087, "project_id": 13, "task_id": 120 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303924, 47.5992659 ], [ -122.3304024, 47.5992826 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311088, "project_id": 13, "task_id": 120 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301718, 47.5992958 ], [ -122.3301664, 47.5992958 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311090, "project_id": 13, "task_id": 120 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3302414, 47.5992866 ], [ -122.3301718, 47.5992958 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311376, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252194, 47.5999691 ], [ -122.325252, 47.6001016 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311377, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249364, 47.6000964 ], [ -122.3249507, 47.5999722 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311378, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249908, 47.5999602 ], [ -122.3251533, 47.5999594 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311379, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.32495, 47.599958 ], [ -122.3249677, 47.5999579 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311380, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249908, 47.5999602 ], [ -122.3249677, 47.5999579 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311381, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249507, 47.5999722 ], [ -122.32495, 47.599958 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311382, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252509, 47.6001146 ], [ -122.3249357, 47.6001153 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311383, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249364, 47.6000964 ], [ -122.3249357, 47.6001153 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311384, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325252, 47.6001016 ], [ -122.3252509, 47.6001146 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311385, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3250028, 47.5990605 ], [ -122.3251417, 47.5990629 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311386, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325229, 47.5991306 ], [ -122.3252163, 47.599262 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311387, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251388, 47.5993406 ], [ -122.3250007, 47.5993315 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311388, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249148, 47.5992637 ], [ -122.3249203, 47.5991292 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311389, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249557, 47.599327 ], [ -122.3249271, 47.5993067 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311390, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249148, 47.5992637 ], [ -122.3249271, 47.5993067 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311391, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3250007, 47.5993315 ], [ -122.3249557, 47.599327 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311392, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249278, 47.5990851 ], [ -122.3249554, 47.5990614 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311393, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3250028, 47.5990605 ], [ -122.3249554, 47.5990614 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311394, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249203, 47.5991292 ], [ -122.3249278, 47.5990851 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311395, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251388, 47.5993406 ], [ -122.3251816, 47.5993376 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311396, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252163, 47.599262 ], [ -122.3252107, 47.5993013 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311397, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251983, 47.5983077 ], [ -122.3251938, 47.5984187 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311398, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251505, 47.5984408 ], [ -122.3249909, 47.5984438 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311399, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249523, 47.5984267 ], [ -122.3249535, 47.5983099 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311400, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3250196, 47.5982749 ], [ -122.3251246, 47.5982719 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311401, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249561, 47.598288 ], [ -122.3249772, 47.5982774 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311402, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3250196, 47.5982749 ], [ -122.3249772, 47.5982774 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311403, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249535, 47.5983099 ], [ -122.3249561, 47.598288 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311404, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249751, 47.5984516 ], [ -122.3249529, 47.5984379 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311405, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249523, 47.5984267 ], [ -122.3249529, 47.5984379 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311406, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249909, 47.5984438 ], [ -122.3249751, 47.5984516 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311407, "project_id": 13, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252672, 47.5974592 ], [ -122.3251837, 47.5975589 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311408, "project_id": 13, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251215, 47.5976086 ], [ -122.3250245, 47.5976059 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311409, "project_id": 13, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249652, 47.5975657 ], [ -122.3249227, 47.5974521 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311410, "project_id": 13, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249876, 47.5974062 ], [ -122.3251681, 47.5974075 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311417, "project_id": 13, "task_id": 86 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251995, 47.5959471 ], [ -122.3251781, 47.5959677 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311418, "project_id": 13, "task_id": 86 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251545, 47.5959468 ], [ -122.3251781, 47.5959677 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311419, "project_id": 13, "task_id": 86 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251806, 47.5959323 ], [ -122.3251995, 47.5959471 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311420, "project_id": 13, "task_id": 86 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249778, 47.5959672 ], [ -122.3249396, 47.5959411 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311421, "project_id": 13, "task_id": 86 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249662, 47.5959293 ], [ -122.3249396, 47.5959411 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311422, "project_id": 13, "task_id": 86 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3250092, 47.5959552 ], [ -122.3249778, 47.5959672 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322850, "project_id": 13, "task_id": 105 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317278, 47.599144 ], [ -122.331708, 47.5992695 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322851, "project_id": 13, "task_id": 105 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3316873, 47.5993104 ], [ -122.3314843, 47.5992962 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322852, "project_id": 13, "task_id": 105 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314692, 47.5992718 ], [ -122.331441, 47.5991406 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322853, "project_id": 13, "task_id": 105 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314953, 47.5990953 ], [ -122.3316903, 47.5991023 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322854, "project_id": 13, "task_id": 105 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314626, 47.5991212 ], [ -122.3314626, 47.5991031 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322855, "project_id": 13, "task_id": 105 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314953, 47.5990953 ], [ -122.3314626, 47.5991031 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322856, "project_id": 13, "task_id": 105 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331441, 47.5991406 ], [ -122.3314626, 47.5991212 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322857, "project_id": 13, "task_id": 105 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33173, 47.5990988 ], [ -122.3317273, 47.5991252 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322858, "project_id": 13, "task_id": 105 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317278, 47.599144 ], [ -122.3317273, 47.5991252 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322859, "project_id": 13, "task_id": 105 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3316903, 47.5991023 ], [ -122.33173, 47.5990988 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322860, "project_id": 13, "task_id": 105 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317225, 47.5992911 ], [ -122.331709, 47.5993168 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322861, "project_id": 13, "task_id": 105 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3316873, 47.5993104 ], [ -122.331709, 47.5993168 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322862, "project_id": 13, "task_id": 105 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331708, 47.5992695 ], [ -122.3317225, 47.5992911 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322863, "project_id": 13, "task_id": 105 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314626, 47.5993182 ], [ -122.3314626, 47.5993001 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322864, "project_id": 13, "task_id": 105 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314692, 47.5992718 ], [ -122.3314626, 47.5993001 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322865, "project_id": 13, "task_id": 105 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314843, 47.5992962 ], [ -122.3314626, 47.5993182 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322866, "project_id": 13, "task_id": 461 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.32881, 47.5992916 ], [ -122.328862, 47.5991204 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322867, "project_id": 13, "task_id": 463 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328862, 47.5991204 ], [ -122.3291741, 47.5991247 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322868, "project_id": 13, "task_id": 463 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328855, 47.5991066 ], [ -122.328882, 47.5991007 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322869, "project_id": 13, "task_id": 463 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328862, 47.5991204 ], [ -122.328882, 47.5991007 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322870, "project_id": 13, "task_id": 463 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328862, 47.5991204 ], [ -122.328855, 47.5991066 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322871, "project_id": 13, "task_id": 465 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291864, 47.5991146 ], [ -122.3294236, 47.5991155 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322872, "project_id": 13, "task_id": 461 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.32881, 47.5992916 ], [ -122.3288349, 47.5993117 ], [ -122.3288597, 47.5993318 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322873, "project_id": 13, "task_id": 465 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291741, 47.5991247 ], [ -122.3291864, 47.5991146 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322874, "project_id": 13, "task_id": 374 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275721, 47.5991047 ], [ -122.3277748, 47.5990516 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322875, "project_id": 13, "task_id": 377 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278967, 47.599128 ], [ -122.3278616, 47.5992906 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322876, "project_id": 13, "task_id": 374 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278038, 47.5993078 ], [ -122.3275761, 47.5993282 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322878, "project_id": 13, "task_id": 376 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275588, 47.5992883 ], [ -122.3275397, 47.5992158 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322882, "project_id": 13, "task_id": 374 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275721, 47.5991047 ], [ -122.3275542, 47.5990896 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322884, "project_id": 13, "task_id": 374 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278052, 47.5990559 ], [ -122.3278296, 47.5990923 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322886, "project_id": 13, "task_id": 374 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277748, 47.5990516 ], [ -122.3278052, 47.5990559 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322887, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262728, 47.5990901 ], [ -122.3262724, 47.5990797 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322888, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326309, 47.5990806 ], [ -122.3262724, 47.5990797 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322889, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326272, 47.5991124 ], [ -122.3262728, 47.5990901 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322891, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264626, 47.5993073 ], [ -122.3264702, 47.5993328 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322892, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264482, 47.5990862 ], [ -122.3264774, 47.5990349 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322893, "project_id": 13, "task_id": 195 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223456, 47.5992815 ], [ -122.3223357, 47.5991259 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322894, "project_id": 13, "task_id": 186 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223834, 47.5990618 ], [ -122.322526, 47.5990545 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322896, "project_id": 13, "task_id": 186 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223834, 47.5990618 ], [ -122.3223385, 47.599067 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322897, "project_id": 13, "task_id": 186 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223357, 47.5991259 ], [ -122.3223385, 47.599067 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322898, "project_id": 13, "task_id": 186 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225686, 47.5990962 ], [ -122.3225708, 47.5992771 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322899, "project_id": 13, "task_id": 195 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223456, 47.5992815 ], [ -122.3223465, 47.5992941 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322900, "project_id": 13, "task_id": 186 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322526, 47.5990545 ], [ -122.3225766, 47.5990718 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322901, "project_id": 13, "task_id": 7 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197756, 47.5991003 ], [ -122.319772, 47.5992767 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322908, "project_id": 13, "task_id": 7 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197756, 47.5991003 ], [ -122.3197755, 47.5990786 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322910, "project_id": 13, "task_id": 7 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319735, 47.5992926 ], [ -122.3195628, 47.5992976 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322912, "project_id": 13, "task_id": 7 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197806, 47.5992984 ], [ -122.319735, 47.5992926 ] ] } }, +{ "type": "Feature", "properties": { "id": 1356586, "project_id": 13, "task_id": 116 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3313613, 47.6008232 ], [ -122.331454, 47.6009165 ] ] } }, +{ "type": "Feature", "properties": { "id": 1356587, "project_id": 13, "task_id": 116 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331427, 47.6009526 ], [ -122.331161, 47.6009649 ] ] } }, +{ "type": "Feature", "properties": { "id": 1356588, "project_id": 13, "task_id": 116 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331099, 47.6009484 ], [ -122.3309495, 47.600817 ] ] } }, +{ "type": "Feature", "properties": { "id": 1356589, "project_id": 13, "task_id": 116 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3309748, 47.6007956 ], [ -122.3313, 47.6008028 ] ] } }, +{ "type": "Feature", "properties": { "id": 1356590, "project_id": 13, "task_id": 511 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3308991, 47.6008134 ], [ -122.3309313, 47.600799 ] ] } }, +{ "type": "Feature", "properties": { "id": 1356591, "project_id": 13, "task_id": 511 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3309748, 47.6007956 ], [ -122.3309313, 47.600799 ] ] } }, +{ "type": "Feature", "properties": { "id": 1356592, "project_id": 13, "task_id": 511 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3309495, 47.600817 ], [ -122.3308991, 47.6008134 ] ] } }, +{ "type": "Feature", "properties": { "id": 1356593, "project_id": 13, "task_id": 116 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3313444, 47.6007974 ], [ -122.3314112, 47.6008061 ] ] } }, +{ "type": "Feature", "properties": { "id": 1356594, "project_id": 13, "task_id": 116 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3313613, 47.6008232 ], [ -122.3314112, 47.6008061 ] ] } }, +{ "type": "Feature", "properties": { "id": 1356595, "project_id": 13, "task_id": 116 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3313, 47.6008028 ], [ -122.3313444, 47.6007974 ] ] } }, +{ "type": "Feature", "properties": { "id": 1356596, "project_id": 13, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314593, 47.6009237 ], [ -122.3314379, 47.600949 ] ] } }, +{ "type": "Feature", "properties": { "id": 1356597, "project_id": 13, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331427, 47.6009526 ], [ -122.3314379, 47.600949 ] ] } }, +{ "type": "Feature", "properties": { "id": 1356598, "project_id": 13, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331454, 47.6009165 ], [ -122.3314593, 47.6009237 ] ] } }, +{ "type": "Feature", "properties": { "id": 1356599, "project_id": 13, "task_id": 116 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331151, 47.6010033 ], [ -122.3310766, 47.6009627 ] ] } }, +{ "type": "Feature", "properties": { "id": 1356600, "project_id": 13, "task_id": 116 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331099, 47.6009484 ], [ -122.3310766, 47.6009627 ] ] } }, +{ "type": "Feature", "properties": { "id": 1356601, "project_id": 13, "task_id": 116 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331161, 47.6009649 ], [ -122.331151, 47.6010033 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366336, "project_id": 13, "task_id": 423 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264471, 47.5967565 ], [ -122.3262953, 47.5967582 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366337, "project_id": 13, "task_id": 423 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262679, 47.5967447 ], [ -122.3262642, 47.5966206 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366339, "project_id": 13, "task_id": 423 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262288, 47.596609 ], [ -122.3262701, 47.5965944 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366341, "project_id": 13, "task_id": 423 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262642, 47.5966206 ], [ -122.3262288, 47.596609 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366342, "project_id": 13, "task_id": 421 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326498, 47.5964609 ], [ -122.3265039, 47.5966089 ], [ -122.326511, 47.5967877 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366343, "project_id": 13, "task_id": 423 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264471, 47.5967565 ], [ -122.326511, 47.5967877 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366345, "project_id": 13, "task_id": 423 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262851, 47.5967683 ], [ -122.326263, 47.5967585 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366346, "project_id": 13, "task_id": 423 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262679, 47.5967447 ], [ -122.326263, 47.5967585 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366347, "project_id": 13, "task_id": 423 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262953, 47.5967582 ], [ -122.3262851, 47.5967683 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366348, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238789, 47.5966018 ], [ -122.3238773, 47.596766 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366349, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238773, 47.596766 ], [ -122.3236964, 47.5967651 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366350, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236474, 47.5967223 ], [ -122.3236453, 47.5966182 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366351, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236773, 47.5965884 ], [ -122.3238789, 47.5966018 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366352, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236185, 47.596605 ], [ -122.3236481, 47.5965789 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366353, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236773, 47.5965884 ], [ -122.3236481, 47.5965789 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366354, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236453, 47.5966182 ], [ -122.3236185, 47.596605 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366355, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238894, 47.5965844 ], [ -122.3239135, 47.5966006 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366356, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238789, 47.5966018 ], [ -122.3239135, 47.5966006 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366357, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238789, 47.5966018 ], [ -122.3238894, 47.5965844 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366358, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239281, 47.5967515 ], [ -122.3239036, 47.5967645 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366359, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238773, 47.596766 ], [ -122.3239036, 47.5967645 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366360, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238773, 47.596766 ], [ -122.3239281, 47.5967515 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366361, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236857, 47.5967651 ], [ -122.3236589, 47.596747 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366362, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236474, 47.5967223 ], [ -122.3236589, 47.596747 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366363, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236964, 47.5967651 ], [ -122.3236857, 47.5967651 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366672, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3230621, 47.6052303 ], [ -122.323147, 47.6053231 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366673, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323132, 47.6053624 ], [ -122.323009, 47.6053994 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366674, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322945, 47.6053931 ], [ -122.3228703, 47.6053088 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366675, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3228887, 47.6052643 ], [ -122.3229987, 47.6052246 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366676, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3230281, 47.6051941 ], [ -122.3230356, 47.6051942 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366677, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3230621, 47.6052303 ], [ -122.3230356, 47.6051942 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366678, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3229987, 47.6052246 ], [ -122.3230281, 47.6051941 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366679, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3231767, 47.6053444 ], [ -122.3231758, 47.6053552 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366680, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323132, 47.6053624 ], [ -122.3231758, 47.6053552 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366681, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323147, 47.6053231 ], [ -122.3231767, 47.6053444 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366682, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3229686, 47.6054256 ], [ -122.3229496, 47.6054207 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366683, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322945, 47.6053931 ], [ -122.3229496, 47.6054207 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366684, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323009, 47.6053994 ], [ -122.3229686, 47.6054256 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366685, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219469, 47.6056786 ], [ -122.3220454, 47.6057832 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366686, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220499, 47.6058174 ], [ -122.3218711, 47.6058827 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366688, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321737, 47.6057408 ], [ -122.3219125, 47.6056675 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366689, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3217021, 47.605765 ], [ -122.3217224, 47.6057417 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366690, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321737, 47.6057408 ], [ -122.3217224, 47.6057417 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366691, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3217185, 47.6057896 ], [ -122.3217021, 47.605765 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366692, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219206, 47.6056566 ], [ -122.3219523, 47.6056619 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366693, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219469, 47.6056786 ], [ -122.3219523, 47.6056619 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366694, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219125, 47.6056675 ], [ -122.3219206, 47.6056566 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366695, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220844, 47.6057852 ], [ -122.3220868, 47.605818 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366696, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220499, 47.6058174 ], [ -122.3220868, 47.605818 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366697, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220454, 47.6057832 ], [ -122.3220844, 47.6057852 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366698, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218595, 47.6058976 ], [ -122.3218102, 47.6058969 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366699, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218037, 47.6058731 ], [ -122.3218102, 47.6058969 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366700, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218711, 47.6058827 ], [ -122.3218595, 47.6058976 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366701, "project_id": 13, "task_id": 532 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329811, 47.6025601 ], [ -122.329634, 47.6026335 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366702, "project_id": 13, "task_id": 532 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329579, 47.6026283 ], [ -122.329484, 47.6025289 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366703, "project_id": 13, "task_id": 532 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329508, 47.602499 ], [ -122.329695, 47.6024425 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366704, "project_id": 13, "task_id": 532 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3294119, 47.6025207 ], [ -122.3294667, 47.6025076 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366705, "project_id": 13, "task_id": 532 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329508, 47.602499 ], [ -122.3294667, 47.6025076 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366706, "project_id": 13, "task_id": 532 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329484, 47.6025289 ], [ -122.3294119, 47.6025207 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366707, "project_id": 13, "task_id": 532 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3297217, 47.6024393 ], [ -122.3298519, 47.6025634 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366708, "project_id": 13, "task_id": 532 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329811, 47.6025601 ], [ -122.3298519, 47.6025634 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366709, "project_id": 13, "task_id": 532 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329695, 47.6024425 ], [ -122.3297217, 47.6024393 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366710, "project_id": 13, "task_id": 532 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3295888, 47.6026653 ], [ -122.329554, 47.6026598 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366711, "project_id": 13, "task_id": 532 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329579, 47.6026283 ], [ -122.329554, 47.6026598 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366712, "project_id": 13, "task_id": 532 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329634, 47.6026335 ], [ -122.3295888, 47.6026653 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366713, "project_id": 13, "task_id": 240 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3286435, 47.6028963 ], [ -122.328723, 47.6029889 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366714, "project_id": 13, "task_id": 240 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3287064, 47.6030162 ], [ -122.3286886, 47.6030249 ], [ -122.3286286, 47.6030539 ], [ -122.3285298, 47.6030949 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366715, "project_id": 13, "task_id": 452 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328484, 47.6030853 ], [ -122.328384, 47.6029823 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366716, "project_id": 13, "task_id": 452 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3283855, 47.6029419 ], [ -122.3285895, 47.6028957 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366717, "project_id": 13, "task_id": 452 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328364, 47.6029742 ], [ -122.328385, 47.6029656 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366718, "project_id": 13, "task_id": 452 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3283855, 47.6029419 ], [ -122.328385, 47.6029656 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366719, "project_id": 13, "task_id": 452 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328384, 47.6029823 ], [ -122.328364, 47.6029742 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366720, "project_id": 13, "task_id": 452 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3285957, 47.6028731 ], [ -122.328628, 47.602879 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366721, "project_id": 13, "task_id": 452 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3286435, 47.6028963 ], [ -122.328628, 47.602879 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366722, "project_id": 13, "task_id": 452 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3285895, 47.6028957 ], [ -122.3285957, 47.6028731 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366723, "project_id": 13, "task_id": 240 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3287549, 47.6029963 ], [ -122.3287267, 47.6030312 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366724, "project_id": 13, "task_id": 240 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3287064, 47.6030162 ], [ -122.3287267, 47.6030312 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366725, "project_id": 13, "task_id": 240 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328723, 47.6029889 ], [ -122.3287549, 47.6029963 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366726, "project_id": 13, "task_id": 452 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3285106, 47.603102 ], [ -122.3284939, 47.6030976 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366727, "project_id": 13, "task_id": 452 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328484, 47.6030853 ], [ -122.3284939, 47.6030976 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366728, "project_id": 13, "task_id": 452 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3285298, 47.6030949 ], [ -122.3285106, 47.603102 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366731, "project_id": 13, "task_id": 451 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3274672, 47.6033594 ], [ -122.3275811, 47.6034725 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366732, "project_id": 13, "task_id": 451 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327453, 47.603332 ], [ -122.3274742, 47.6033497 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366733, "project_id": 13, "task_id": 451 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3274672, 47.6033594 ], [ -122.3274742, 47.6033497 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366735, "project_id": 13, "task_id": 451 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3276041, 47.6034773 ], [ -122.3276103, 47.6034876 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366737, "project_id": 13, "task_id": 451 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275811, 47.6034725 ], [ -122.3276041, 47.6034773 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366738, "project_id": 13, "task_id": 451 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3274133, 47.603543 ], [ -122.3272912, 47.6034065 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366765, "project_id": 13, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3368586, 47.6035608 ], [ -122.336698, 47.603633 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366766, "project_id": 13, "task_id": 353 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3374289, 47.6041395 ], [ -122.3375181, 47.6042425 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366767, "project_id": 13, "task_id": 353 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3375089, 47.6042815 ], [ -122.3373632, 47.604347 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366768, "project_id": 13, "task_id": 353 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3373104, 47.6043284 ], [ -122.3372087, 47.6042252 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366769, "project_id": 13, "task_id": 353 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3372069, 47.6041914 ], [ -122.3373658, 47.6041304 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366770, "project_id": 13, "task_id": 353 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3371805, 47.6042115 ], [ -122.3371318, 47.6041775 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366771, "project_id": 13, "task_id": 353 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3372069, 47.6041914 ], [ -122.3371318, 47.6041775 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366773, "project_id": 13, "task_id": 353 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3373623, 47.6040835 ], [ -122.337422, 47.6040964 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366774, "project_id": 13, "task_id": 353 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3374289, 47.6041395 ], [ -122.337422, 47.6040964 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366775, "project_id": 13, "task_id": 353 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3373658, 47.6041304 ], [ -122.3373623, 47.6040835 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366776, "project_id": 13, "task_id": 353 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3375634, 47.6042751 ], [ -122.3375553, 47.6042986 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366777, "project_id": 13, "task_id": 353 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3375089, 47.6042815 ], [ -122.3375553, 47.6042986 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366778, "project_id": 13, "task_id": 353 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3375181, 47.6042425 ], [ -122.3375634, 47.6042751 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366779, "project_id": 13, "task_id": 353 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3373472, 47.6043644 ], [ -122.3372826, 47.6043531 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366780, "project_id": 13, "task_id": 353 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3373104, 47.6043284 ], [ -122.3372826, 47.6043531 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366781, "project_id": 13, "task_id": 353 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3373632, 47.604347 ], [ -122.3373472, 47.6043644 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366782, "project_id": 13, "task_id": 349 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3381598, 47.6049638 ], [ -122.3380205, 47.6050304 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366783, "project_id": 13, "task_id": 349 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3379433, 47.6050142 ], [ -122.3378827, 47.6049386 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366785, "project_id": 13, "task_id": 8 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3388318, 47.6057111 ], [ -122.3386522, 47.6057639 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366787, "project_id": 13, "task_id": 8 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3385196, 47.6056113 ], [ -122.338654, 47.6055578 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366789, "project_id": 13, "task_id": 8 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3385196, 47.6056113 ], [ -122.3385045, 47.6056277 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366791, "project_id": 13, "task_id": 8 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.338687, 47.6055394 ], [ -122.3387165, 47.6055376 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366793, "project_id": 13, "task_id": 8 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.338654, 47.6055578 ], [ -122.338687, 47.6055394 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366797, "project_id": 13, "task_id": 8 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3386429, 47.6057742 ], [ -122.3386254, 47.6057581 ], [ -122.3385638, 47.6057768 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366799, "project_id": 13, "task_id": 8 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3386522, 47.6057639 ], [ -122.3386429, 47.6057742 ] ] } }, +{ "type": "Feature", "properties": { "id": 1388437, "project_id": 13, "task_id": 456 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3292376, 47.6009911 ], [ -122.329146, 47.6010613 ] ] } }, +{ "type": "Feature", "properties": { "id": 1388438, "project_id": 13, "task_id": 504 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3292301, 47.6008194 ], [ -122.3292519, 47.6009444 ] ] } }, +{ "type": "Feature", "properties": { "id": 1388439, "project_id": 13, "task_id": 456 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329104, 47.6010727 ], [ -122.3288872, 47.6009648 ] ] } }, +{ "type": "Feature", "properties": { "id": 1388441, "project_id": 13, "task_id": 456 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328849, 47.6009394 ], [ -122.328862, 47.6008217 ] ] } }, +{ "type": "Feature", "properties": { "id": 1388442, "project_id": 13, "task_id": 456 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288291, 47.6008091 ], [ -122.3288506, 47.6008109 ] ] } }, +{ "type": "Feature", "properties": { "id": 1388443, "project_id": 13, "task_id": 456 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328895, 47.6007895 ], [ -122.3288506, 47.6008109 ] ] } }, +{ "type": "Feature", "properties": { "id": 1388444, "project_id": 13, "task_id": 456 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328862, 47.6008217 ], [ -122.3288291, 47.6008091 ] ] } }, +{ "type": "Feature", "properties": { "id": 1388447, "project_id": 13, "task_id": 504 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3292301, 47.6008194 ], [ -122.3292588, 47.6008093 ] ] } }, +{ "type": "Feature", "properties": { "id": 1388448, "project_id": 13, "task_id": 504 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3292794, 47.6009573 ], [ -122.3292619, 47.6009793 ] ] } }, +{ "type": "Feature", "properties": { "id": 1388449, "project_id": 13, "task_id": 504 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3292376, 47.6009911 ], [ -122.3292619, 47.6009793 ] ] } }, +{ "type": "Feature", "properties": { "id": 1388450, "project_id": 13, "task_id": 504 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3292519, 47.6009444 ], [ -122.3292794, 47.6009573 ] ] } }, +{ "type": "Feature", "properties": { "id": 1388451, "project_id": 13, "task_id": 456 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288647, 47.6009772 ], [ -122.3288238, 47.6009519 ] ] } }, +{ "type": "Feature", "properties": { "id": 1388452, "project_id": 13, "task_id": 456 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328849, 47.6009394 ], [ -122.3288238, 47.6009519 ] ] } }, +{ "type": "Feature", "properties": { "id": 1388453, "project_id": 13, "task_id": 456 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288872, 47.6009648 ], [ -122.3288647, 47.6009772 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389863, "project_id": 13, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331458, 47.5999791 ], [ -122.3317115, 47.5999497 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389864, "project_id": 13, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331758, 47.599983 ], [ -122.3317468, 47.6001111 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389865, "project_id": 13, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331699, 47.6001364 ], [ -122.3315299, 47.600127 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389866, "project_id": 13, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3315002, 47.6001035 ], [ -122.331458, 47.5999791 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389867, "project_id": 13, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314353, 47.5999704 ], [ -122.3314539, 47.5999489 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389868, "project_id": 13, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331458, 47.5999791 ], [ -122.3314539, 47.5999489 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389869, "project_id": 13, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331458, 47.5999791 ], [ -122.3314353, 47.5999704 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389871, "project_id": 13, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331758, 47.599983 ], [ -122.3317352, 47.5999691 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389872, "project_id": 13, "task_id": 106 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317115, 47.5999497 ], [ -122.3317276, 47.599957 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389873, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262002, 47.5999598 ], [ -122.3262529, 47.5999586 ], [ -122.3262539, 47.5999316 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389874, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262788, 47.5999314 ], [ -122.3262539, 47.5999316 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389875, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3261993, 47.5999745 ], [ -122.3262002, 47.5999598 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389876, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264915, 47.5999326 ], [ -122.326492, 47.599958 ], [ -122.3265315, 47.5999572 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389877, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265323, 47.5999736 ], [ -122.3265315, 47.5999572 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389878, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264683, 47.5999323 ], [ -122.3264915, 47.5999326 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389879, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265335, 47.6001188 ], [ -122.3264893, 47.6001207 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389880, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264819, 47.6001098 ], [ -122.3264893, 47.6001207 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389881, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265334, 47.6001025 ], [ -122.3265335, 47.6001188 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389882, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262497, 47.6001176 ], [ -122.3262023, 47.6001159 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389883, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326204, 47.6000982 ], [ -122.3262023, 47.6001159 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389884, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262797, 47.6001152 ], [ -122.3262497, 47.6001176 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399271, "project_id": 13, "task_id": 351 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3370192, 47.6045209 ], [ -122.3368557, 47.6045841 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399272, "project_id": 13, "task_id": 351 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3368075, 47.6045751 ], [ -122.336652, 47.604407 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399273, "project_id": 13, "task_id": 351 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3368584, 47.6043221 ], [ -122.3370112, 47.6044901 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399274, "project_id": 13, "task_id": 351 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3366467, 47.6043998 ], [ -122.3368504, 47.6043148 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399275, "project_id": 13, "task_id": 351 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3368584, 47.6043221 ], [ -122.3368504, 47.6043148 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399276, "project_id": 13, "task_id": 351 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336652, 47.604407 ], [ -122.3366467, 47.6043998 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399277, "project_id": 13, "task_id": 351 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3370192, 47.6044992 ], [ -122.3370326, 47.6045154 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399278, "project_id": 13, "task_id": 351 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3370192, 47.6045209 ], [ -122.3370326, 47.6045154 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399279, "project_id": 13, "task_id": 351 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3370112, 47.6044901 ], [ -122.3370192, 47.6044992 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399280, "project_id": 13, "task_id": 351 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336845, 47.6045895 ], [ -122.3368128, 47.6045823 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399281, "project_id": 13, "task_id": 351 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3368075, 47.6045751 ], [ -122.3368128, 47.6045823 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399282, "project_id": 13, "task_id": 351 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3368557, 47.6045841 ], [ -122.336845, 47.6045895 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399283, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3375534, 47.6050947 ], [ -122.3376089, 47.6051746 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399284, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3376089, 47.6051746 ], [ -122.3374465, 47.605251 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399285, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3374465, 47.605251 ], [ -122.337401, 47.6051356 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399286, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.337401, 47.6051356 ], [ -122.3375534, 47.6050947 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399287, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.337339, 47.6051543 ], [ -122.3373856, 47.6051212 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399288, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.337401, 47.6051356 ], [ -122.3373856, 47.6051212 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399289, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.337401, 47.6051356 ], [ -122.337339, 47.6051543 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399290, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3374933, 47.6050862 ], [ -122.337552, 47.6050731 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399291, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3375534, 47.6050947 ], [ -122.337552, 47.6050731 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399292, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3375534, 47.6050947 ], [ -122.3374933, 47.6050862 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399293, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3376407, 47.6051763 ], [ -122.3376032, 47.6051925 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399294, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3376089, 47.6051746 ], [ -122.3376032, 47.6051925 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399295, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3376089, 47.6051746 ], [ -122.3376407, 47.6051763 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399296, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3374546, 47.6052612 ], [ -122.3374397, 47.605263 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399297, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3374465, 47.605251 ], [ -122.3374397, 47.605263 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399298, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3374465, 47.605251 ], [ -122.3374546, 47.6052612 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399299, "project_id": 13, "task_id": 8 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3384975, 47.6056659 ], [ -122.3385638, 47.6057768 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399302, "project_id": 13, "task_id": 8 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3384975, 47.6056659 ], [ -122.3384826, 47.6056554 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399307, "project_id": 13, "task_id": 512 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355422, 47.6029532 ], [ -122.3356494, 47.6030781 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399308, "project_id": 13, "task_id": 512 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3356494, 47.6030781 ], [ -122.335562, 47.603109 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399309, "project_id": 13, "task_id": 512 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335562, 47.603109 ], [ -122.3354425, 47.6029956 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399310, "project_id": 13, "task_id": 512 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354425, 47.6029956 ], [ -122.3355422, 47.6029532 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399311, "project_id": 13, "task_id": 512 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3353819, 47.6030083 ], [ -122.335415, 47.6029862 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399312, "project_id": 13, "task_id": 512 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354425, 47.6029956 ], [ -122.335415, 47.6029862 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399313, "project_id": 13, "task_id": 512 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354425, 47.6029956 ], [ -122.3353819, 47.6030083 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399314, "project_id": 13, "task_id": 512 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355281, 47.6029318 ], [ -122.3355767, 47.6029299 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399315, "project_id": 13, "task_id": 512 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355422, 47.6029532 ], [ -122.3355767, 47.6029299 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399316, "project_id": 13, "task_id": 512 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355422, 47.6029532 ], [ -122.3355281, 47.6029318 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399317, "project_id": 13, "task_id": 512 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3357072, 47.6030451 ], [ -122.3357098, 47.6030609 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399318, "project_id": 13, "task_id": 512 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3356494, 47.6030781 ], [ -122.3357098, 47.6030609 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399319, "project_id": 13, "task_id": 512 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3356494, 47.6030781 ], [ -122.3357072, 47.6030451 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399320, "project_id": 13, "task_id": 512 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355572, 47.6031331 ], [ -122.3355242, 47.6031131 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399321, "project_id": 13, "task_id": 512 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335562, 47.603109 ], [ -122.3355242, 47.6031131 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399322, "project_id": 13, "task_id": 512 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335562, 47.603109 ], [ -122.3355572, 47.6031331 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399323, "project_id": 13, "task_id": 439 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336223, 47.6036206 ], [ -122.336379, 47.6037887 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399324, "project_id": 13, "task_id": 439 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336199, 47.6038664 ], [ -122.336038, 47.6036984 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399325, "project_id": 13, "task_id": 439 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33603, 47.6036694 ], [ -122.336191, 47.6036044 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399326, "project_id": 13, "task_id": 439 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360333, 47.6036929 ], [ -122.3360199, 47.6036749 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399327, "project_id": 13, "task_id": 439 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33603, 47.6036694 ], [ -122.3360199, 47.6036749 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399328, "project_id": 13, "task_id": 439 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336038, 47.6036984 ], [ -122.3360333, 47.6036929 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399329, "project_id": 13, "task_id": 439 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3362021, 47.603599 ], [ -122.3362182, 47.6036134 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399330, "project_id": 13, "task_id": 439 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336223, 47.6036206 ], [ -122.3362182, 47.6036134 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399331, "project_id": 13, "task_id": 439 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336191, 47.6036044 ], [ -122.3362021, 47.603599 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399332, "project_id": 13, "task_id": 439 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3363844, 47.6037978 ], [ -122.3362075, 47.6038737 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399333, "project_id": 13, "task_id": 439 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336199, 47.6038664 ], [ -122.3362075, 47.6038737 ] ] } }, +{ "type": "Feature", "properties": { "id": 1399334, "project_id": 13, "task_id": 439 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336379, 47.6037887 ], [ -122.3363844, 47.6037978 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407575, "project_id": 13, "task_id": 525 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329452, 47.6020629 ], [ -122.329556, 47.6021823 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407576, "project_id": 13, "task_id": 525 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3293948, 47.6020343 ], [ -122.3294387, 47.6020545 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407577, "project_id": 13, "task_id": 525 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329452, 47.6020629 ], [ -122.3294387, 47.6020545 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407579, "project_id": 13, "task_id": 525 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3295799, 47.6021603 ], [ -122.329556, 47.6021823 ], [ -122.3295523, 47.602198 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407581, "project_id": 13, "task_id": 525 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329556, 47.6021823 ], [ -122.3295799, 47.6021603 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407974, "project_id": 13, "task_id": 128 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3284576, 47.6062037 ], [ -122.3283164, 47.6062605 ], [ -122.3283432, 47.6062583 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407975, "project_id": 13, "task_id": 128 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3282209, 47.6061409 ], [ -122.328138, 47.6060637 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407976, "project_id": 13, "task_id": 128 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328138, 47.6060637 ], [ -122.3282646, 47.6059904 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407977, "project_id": 13, "task_id": 128 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3280865, 47.6060646 ], [ -122.3281093, 47.606049 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407978, "project_id": 13, "task_id": 128 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328138, 47.6060637 ], [ -122.3281093, 47.606049 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407979, "project_id": 13, "task_id": 128 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328138, 47.6060637 ], [ -122.3280865, 47.6060646 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407980, "project_id": 13, "task_id": 128 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3282753, 47.6059868 ], [ -122.3284683, 47.6062 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407981, "project_id": 13, "task_id": 128 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3284576, 47.6062037 ], [ -122.3284683, 47.6062 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407982, "project_id": 13, "task_id": 128 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3282646, 47.6059904 ], [ -122.3282753, 47.6059868 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407983, "project_id": 13, "task_id": 128 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3283164, 47.6062605 ], [ -122.3282389, 47.6061672 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407984, "project_id": 13, "task_id": 128 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3282209, 47.6061409 ], [ -122.3282389, 47.6061672 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407985, "project_id": 13, "task_id": 128 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3283432, 47.6062583 ], [ -122.3283164, 47.6062605 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407986, "project_id": 13, "task_id": 61 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3272291, 47.6064037 ], [ -122.3273471, 47.6065609 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407987, "project_id": 13, "task_id": 60 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3273337, 47.6065971 ], [ -122.3271514, 47.6066766 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407988, "project_id": 13, "task_id": 60 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3270951, 47.6066676 ], [ -122.3270537, 47.6065369 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407989, "project_id": 13, "task_id": 61 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3270962, 47.6064876 ], [ -122.3271728, 47.6063947 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407990, "project_id": 13, "task_id": 60 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3270095, 47.6065314 ], [ -122.3270257, 47.6065014 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407991, "project_id": 13, "task_id": 60 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3270962, 47.6064876 ], [ -122.3270257, 47.6065014 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407992, "project_id": 13, "task_id": 60 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3270537, 47.6065369 ], [ -122.3270095, 47.6065314 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407993, "project_id": 13, "task_id": 61 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3271836, 47.6063911 ], [ -122.3272238, 47.6063965 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407994, "project_id": 13, "task_id": 61 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3272291, 47.6064037 ], [ -122.3272238, 47.6063965 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407995, "project_id": 13, "task_id": 61 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3271728, 47.6063947 ], [ -122.3271836, 47.6063911 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407996, "project_id": 13, "task_id": 61 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3273551, 47.6065682 ], [ -122.3273444, 47.6065935 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407997, "project_id": 13, "task_id": 61 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3273337, 47.6065971 ], [ -122.3273444, 47.6065935 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407998, "project_id": 13, "task_id": 61 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3273471, 47.6065609 ], [ -122.3273551, 47.6065682 ] ] } }, +{ "type": "Feature", "properties": { "id": 1407999, "project_id": 13, "task_id": 60 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3271407, 47.6066802 ], [ -122.3271032, 47.6066748 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408000, "project_id": 13, "task_id": 60 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3270951, 47.6066676 ], [ -122.3271032, 47.6066748 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408001, "project_id": 13, "task_id": 60 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3271514, 47.6066766 ], [ -122.3271407, 47.6066802 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408002, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3250199, 47.6073744 ], [ -122.3250893, 47.6074491 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408003, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3250752, 47.6074968 ], [ -122.3249685, 47.6075403 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408004, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3248962, 47.6075322 ], [ -122.3248293, 47.6074556 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408005, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3248483, 47.6074101 ], [ -122.3249582, 47.6073694 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408006, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3248043, 47.6074263 ], [ -122.3248241, 47.6074187 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408007, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3248483, 47.6074101 ], [ -122.3248241, 47.6074187 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408008, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3248293, 47.6074556 ], [ -122.3248043, 47.6074263 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408009, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249832, 47.6073526 ], [ -122.325001, 47.6073552 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408010, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3250199, 47.6073744 ], [ -122.325001, 47.6073552 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408011, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249582, 47.6073694 ], [ -122.3249832, 47.6073526 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408012, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251136, 47.6074712 ], [ -122.3251194, 47.6074777 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408013, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3250752, 47.6074968 ], [ -122.3251194, 47.6074777 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408014, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3250893, 47.6074491 ], [ -122.3251136, 47.6074712 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408016, "project_id": 13, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239305, 47.6078213 ], [ -122.3239086, 47.6078052 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408020, "project_id": 13, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240023, 47.607948 ], [ -122.3240111, 47.6079369 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408021, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3228573, 47.6084223 ], [ -122.3227469, 47.6084676 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408022, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226364, 47.6083524 ], [ -122.3227747, 47.6082874 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408023, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3227747, 47.6082874 ], [ -122.3228735, 47.6083747 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408025, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3227747, 47.6082874 ], [ -122.3227784, 47.6082822 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408026, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3227747, 47.6082874 ], [ -122.3227784, 47.6082822 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408027, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3229038, 47.6084046 ], [ -122.3228992, 47.6084066 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408028, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3228573, 47.6084223 ], [ -122.3228992, 47.6084066 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408029, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3228735, 47.6083747 ], [ -122.3229038, 47.6084046 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408033, "project_id": 13, "task_id": 514 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3350221, 47.6031698 ], [ -122.335132, 47.6032611 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408034, "project_id": 13, "task_id": 514 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3351138, 47.6033035 ], [ -122.3349096, 47.6033799 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408035, "project_id": 13, "task_id": 514 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3348602, 47.6033807 ], [ -122.334763, 47.6032647 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408036, "project_id": 13, "task_id": 514 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3347772, 47.6032372 ], [ -122.3349697, 47.6031497 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408037, "project_id": 13, "task_id": 514 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3347549, 47.6032575 ], [ -122.334763, 47.6032322 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408038, "project_id": 13, "task_id": 514 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3347772, 47.6032372 ], [ -122.334763, 47.6032322 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408039, "project_id": 13, "task_id": 514 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.334763, 47.6032647 ], [ -122.3347549, 47.6032575 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408040, "project_id": 13, "task_id": 514 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3349908, 47.6031382 ], [ -122.335031, 47.6031454 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408041, "project_id": 13, "task_id": 514 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3350221, 47.6031698 ], [ -122.335031, 47.6031454 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408042, "project_id": 13, "task_id": 514 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3349697, 47.6031497 ], [ -122.3349908, 47.6031382 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408043, "project_id": 13, "task_id": 514 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3351382, 47.6032701 ], [ -122.3351436, 47.6033081 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408044, "project_id": 13, "task_id": 514 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3351138, 47.6033035 ], [ -122.3351436, 47.6033081 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408045, "project_id": 13, "task_id": 514 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335132, 47.6032611 ], [ -122.3351382, 47.6032701 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408046, "project_id": 13, "task_id": 514 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3349158, 47.6034021 ], [ -122.334864, 47.6033967 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408047, "project_id": 13, "task_id": 514 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3348602, 47.6033807 ], [ -122.334864, 47.6033967 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408048, "project_id": 13, "task_id": 514 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3349096, 47.6033799 ], [ -122.3349158, 47.6034021 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408049, "project_id": 13, "task_id": 516 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333938, 47.6036215 ], [ -122.3340161, 47.6037271 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408050, "project_id": 13, "task_id": 516 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340006, 47.6037678 ], [ -122.3338014, 47.6038423 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408051, "project_id": 13, "task_id": 498 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3337519, 47.6038372 ], [ -122.3336494, 47.6037451 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408052, "project_id": 13, "task_id": 498 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3336663, 47.6036958 ], [ -122.3338744, 47.6036266 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408053, "project_id": 13, "task_id": 498 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333627, 47.6037321 ], [ -122.3336311, 47.6037208 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408054, "project_id": 13, "task_id": 498 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3336663, 47.6036958 ], [ -122.3336311, 47.6037208 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408055, "project_id": 13, "task_id": 498 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3336494, 47.6037451 ], [ -122.333627, 47.6037321 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408056, "project_id": 13, "task_id": 498 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3339026, 47.6036042 ], [ -122.3339267, 47.6036041 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408057, "project_id": 13, "task_id": 498 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333938, 47.6036215 ], [ -122.3339267, 47.6036041 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408058, "project_id": 13, "task_id": 498 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3338744, 47.6036266 ], [ -122.3339026, 47.6036042 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408060, "project_id": 13, "task_id": 516 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340006, 47.6037678 ], [ -122.3340621, 47.6037377 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408063, "project_id": 13, "task_id": 498 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3337519, 47.6038372 ], [ -122.3337579, 47.6038578 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408064, "project_id": 13, "task_id": 498 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3338014, 47.6038423 ], [ -122.3337579, 47.6038578 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408065, "project_id": 13, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327957, 47.6041063 ], [ -122.3328915, 47.6041957 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408066, "project_id": 13, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332885, 47.6042418 ], [ -122.3326805, 47.6043035 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408067, "project_id": 13, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3326805, 47.6043035 ], [ -122.332574, 47.6041946 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408068, "project_id": 13, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332574, 47.6041946 ], [ -122.3327434, 47.6040996 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408069, "project_id": 13, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3325285, 47.6042 ], [ -122.3325578, 47.6041783 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408070, "project_id": 13, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332574, 47.6041946 ], [ -122.3325578, 47.6041783 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408071, "project_id": 13, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332574, 47.6041946 ], [ -122.3325285, 47.6042 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408072, "project_id": 13, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327607, 47.6040851 ], [ -122.3327905, 47.60409 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408073, "project_id": 13, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327957, 47.6041063 ], [ -122.3327905, 47.60409 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408074, "project_id": 13, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327434, 47.6040996 ], [ -122.3327607, 47.6040851 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408075, "project_id": 13, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3329116, 47.604215 ], [ -122.3329132, 47.6042327 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408076, "project_id": 13, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332885, 47.6042418 ], [ -122.3329132, 47.6042327 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408077, "project_id": 13, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3328915, 47.6041957 ], [ -122.3329116, 47.604215 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408079, "project_id": 13, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3326805, 47.6043035 ], [ -122.3326644, 47.6043131 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408081, "project_id": 13, "task_id": 466 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317042, 47.6045678 ], [ -122.3317737, 47.6046803 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408082, "project_id": 13, "task_id": 466 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317737, 47.6046803 ], [ -122.3316227, 47.6047981 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408083, "project_id": 13, "task_id": 466 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3315537, 47.6047699 ], [ -122.3314224, 47.6046833 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408084, "project_id": 13, "task_id": 466 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314475, 47.6046326 ], [ -122.3316556, 47.6045675 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408085, "project_id": 13, "task_id": 469 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314101, 47.6046687 ], [ -122.3314245, 47.6046422 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408086, "project_id": 13, "task_id": 466 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314475, 47.6046326 ], [ -122.3314245, 47.6046422 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408087, "project_id": 13, "task_id": 469 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314224, 47.6046833 ], [ -122.3314101, 47.6046687 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408088, "project_id": 13, "task_id": 466 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3316563, 47.6045467 ], [ -122.3316935, 47.6045539 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408089, "project_id": 13, "task_id": 466 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317042, 47.6045678 ], [ -122.3316935, 47.6045539 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408090, "project_id": 13, "task_id": 466 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3316556, 47.6045675 ], [ -122.3316563, 47.6045467 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408091, "project_id": 13, "task_id": 466 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3318, 47.6046903 ], [ -122.3318163, 47.6047027 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408093, "project_id": 13, "task_id": 466 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317737, 47.6046803 ], [ -122.3318, 47.6046903 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408094, "project_id": 13, "task_id": 466 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3315914, 47.6048133 ], [ -122.3315684, 47.604791 ], [ -122.3315436, 47.6047886 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408095, "project_id": 13, "task_id": 466 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3315537, 47.6047699 ], [ -122.3315436, 47.6047886 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408096, "project_id": 13, "task_id": 466 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3316227, 47.6047981 ], [ -122.3315914, 47.6048133 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408097, "project_id": 13, "task_id": 386 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3306496, 47.6051659 ], [ -122.3304738, 47.605228 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408098, "project_id": 13, "task_id": 386 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3305603, 47.6050355 ], [ -122.3306496, 47.6051659 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408101, "project_id": 13, "task_id": 124 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3294473, 47.6055233 ], [ -122.329517, 47.6056032 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408102, "project_id": 13, "task_id": 124 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3293906, 47.6054643 ], [ -122.3294333, 47.6055003 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408103, "project_id": 13, "task_id": 124 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3294473, 47.6055233 ], [ -122.3294333, 47.6055003 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408107, "project_id": 13, "task_id": 124 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329517, 47.6056032 ], [ -122.329525, 47.6056104 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408108, "project_id": 13, "task_id": 124 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3292733, 47.6057116 ], [ -122.32915, 47.6055706 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411675, "project_id": 13, "task_id": 218 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3369609, 47.6053125 ], [ -122.3370466, 47.605409 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411676, "project_id": 13, "task_id": 218 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3370466, 47.605409 ], [ -122.3368556, 47.6055078 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411677, "project_id": 13, "task_id": 218 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3368556, 47.6055078 ], [ -122.3367615, 47.6053988 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411678, "project_id": 13, "task_id": 218 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3367615, 47.6053988 ], [ -122.3369609, 47.6053125 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411679, "project_id": 13, "task_id": 218 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3367043, 47.6054036 ], [ -122.3367123, 47.6053783 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411680, "project_id": 13, "task_id": 218 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3367615, 47.6053988 ], [ -122.3367123, 47.6053783 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411681, "project_id": 13, "task_id": 218 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3367615, 47.6053988 ], [ -122.3367043, 47.6054036 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411682, "project_id": 13, "task_id": 218 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3369402, 47.6052843 ], [ -122.336975, 47.6052897 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411683, "project_id": 13, "task_id": 218 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3369609, 47.6053125 ], [ -122.336975, 47.6052897 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411684, "project_id": 13, "task_id": 218 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3369609, 47.6053125 ], [ -122.3369402, 47.6052843 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411685, "project_id": 13, "task_id": 218 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3370876, 47.6054126 ], [ -122.3370796, 47.6054379 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411686, "project_id": 13, "task_id": 218 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3370466, 47.605409 ], [ -122.3370796, 47.6054379 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411687, "project_id": 13, "task_id": 218 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3370466, 47.605409 ], [ -122.3370876, 47.6054126 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411688, "project_id": 13, "task_id": 218 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3368517, 47.6055319 ], [ -122.3368169, 47.6055265 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411689, "project_id": 13, "task_id": 218 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3368556, 47.6055078 ], [ -122.3368169, 47.6055265 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411690, "project_id": 13, "task_id": 218 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3368556, 47.6055078 ], [ -122.3368517, 47.6055319 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411691, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358937, 47.6057653 ], [ -122.3359695, 47.6058604 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411692, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3359467, 47.6058966 ], [ -122.3357653, 47.6059834 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411693, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3357175, 47.6059851 ], [ -122.3356136, 47.6058807 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411694, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3356208, 47.605836 ], [ -122.3358379, 47.6057675 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411695, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355884, 47.6058755 ], [ -122.3355932, 47.6058566 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411696, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3356208, 47.605836 ], [ -122.3355932, 47.6058566 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411697, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3356136, 47.6058807 ], [ -122.3355884, 47.6058755 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411699, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358937, 47.6057653 ], [ -122.3358759, 47.6057492 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411700, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358379, 47.6057675 ], [ -122.3358579, 47.6057451 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411702, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3357175, 47.6059851 ], [ -122.3357153, 47.6059981 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411703, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3357653, 47.6059834 ], [ -122.3357323, 47.6059988 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411704, "project_id": 13, "task_id": 300 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3347679, 47.6062511 ], [ -122.334845, 47.6063436 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411705, "project_id": 13, "task_id": 300 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3348371, 47.6063791 ], [ -122.3346611, 47.6064457 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411706, "project_id": 13, "task_id": 300 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3345965, 47.6064399 ], [ -122.3345033, 47.6063383 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411707, "project_id": 13, "task_id": 300 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3345293, 47.6063079 ], [ -122.3347082, 47.6062405 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411708, "project_id": 13, "task_id": 300 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3344919, 47.6063328 ], [ -122.3345, 47.6063093 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411709, "project_id": 13, "task_id": 300 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3345293, 47.6063079 ], [ -122.3345, 47.6063093 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411710, "project_id": 13, "task_id": 300 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3345033, 47.6063383 ], [ -122.3344919, 47.6063328 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411711, "project_id": 13, "task_id": 300 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3347359, 47.6062188 ], [ -122.334759, 47.6062285 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411712, "project_id": 13, "task_id": 300 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3347679, 47.6062511 ], [ -122.334759, 47.6062285 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411713, "project_id": 13, "task_id": 300 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3347082, 47.6062405 ], [ -122.3347359, 47.6062188 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411715, "project_id": 13, "task_id": 300 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3348371, 47.6063791 ], [ -122.3348672, 47.6063671 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411716, "project_id": 13, "task_id": 300 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.334845, 47.6063436 ], [ -122.3348626, 47.6063517 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411717, "project_id": 13, "task_id": 300 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3346446, 47.6064554 ], [ -122.3346065, 47.6064512 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411718, "project_id": 13, "task_id": 300 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3345965, 47.6064399 ], [ -122.3346065, 47.6064512 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411719, "project_id": 13, "task_id": 300 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3346611, 47.6064457 ], [ -122.3346446, 47.6064554 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411720, "project_id": 13, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333663, 47.6066986 ], [ -122.3337403, 47.6068086 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411721, "project_id": 13, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3337377, 47.606843 ], [ -122.3335401, 47.6069066 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411722, "project_id": 13, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3334947, 47.6069144 ], [ -122.3333871, 47.6068103 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411723, "project_id": 13, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3334105, 47.6067687 ], [ -122.3335829, 47.6066828 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411724, "project_id": 13, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3333652, 47.6068069 ], [ -122.3333845, 47.606778 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411725, "project_id": 13, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3334105, 47.6067687 ], [ -122.3333845, 47.606778 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411726, "project_id": 13, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3333871, 47.6068103 ], [ -122.3333652, 47.6068069 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411727, "project_id": 13, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3336272, 47.6066752 ], [ -122.333654, 47.6066813 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411728, "project_id": 13, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333663, 47.6066986 ], [ -122.333654, 47.6066813 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411729, "project_id": 13, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3335829, 47.6066828 ], [ -122.3336272, 47.6066752 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411730, "project_id": 13, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3337672, 47.6068179 ], [ -122.3337609, 47.6068361 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411731, "project_id": 13, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3337377, 47.606843 ], [ -122.3337609, 47.6068361 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411732, "project_id": 13, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3337403, 47.6068086 ], [ -122.3337672, 47.6068179 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411733, "project_id": 13, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3335312, 47.6069323 ], [ -122.3334891, 47.6069298 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411734, "project_id": 13, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3334947, 47.6069144 ], [ -122.3334891, 47.6069298 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411735, "project_id": 13, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3335401, 47.6069066 ], [ -122.3335312, 47.6069323 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411736, "project_id": 13, "task_id": 260 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3325186, 47.6071582 ], [ -122.33261, 47.6072863 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411737, "project_id": 13, "task_id": 260 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33261, 47.6072863 ], [ -122.33251, 47.607398 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411738, "project_id": 13, "task_id": 260 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332412, 47.6073689 ], [ -122.332329, 47.6072518 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411739, "project_id": 13, "task_id": 260 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332329, 47.6072518 ], [ -122.3324803, 47.6071505 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411740, "project_id": 13, "task_id": 260 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3323196, 47.6073004 ], [ -122.3322902, 47.6072387 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411741, "project_id": 13, "task_id": 260 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332329, 47.6072518 ], [ -122.3322902, 47.6072387 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411742, "project_id": 13, "task_id": 260 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332329, 47.6072518 ], [ -122.3323196, 47.6073004 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411743, "project_id": 13, "task_id": 260 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3325033, 47.6071441 ], [ -122.3325255, 47.6071499 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411744, "project_id": 13, "task_id": 260 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3325186, 47.6071582 ], [ -122.3325255, 47.6071499 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411745, "project_id": 13, "task_id": 260 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3324803, 47.6071505 ], [ -122.3325033, 47.6071441 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411746, "project_id": 13, "task_id": 260 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3326682, 47.6072713 ], [ -122.3326547, 47.6073282 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411747, "project_id": 13, "task_id": 260 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33261, 47.6072863 ], [ -122.3326547, 47.6073282 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411748, "project_id": 13, "task_id": 260 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33261, 47.6072863 ], [ -122.3326682, 47.6072713 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411749, "project_id": 13, "task_id": 260 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3324296, 47.6073905 ], [ -122.3323948, 47.6073851 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411750, "project_id": 13, "task_id": 260 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332412, 47.6073689 ], [ -122.3323948, 47.6073851 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411751, "project_id": 13, "task_id": 260 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33251, 47.607398 ], [ -122.3324296, 47.6073905 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411752, "project_id": 13, "task_id": 417 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301612, 47.6082827 ], [ -122.3301013, 47.6082043 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411753, "project_id": 13, "task_id": 307 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291778, 47.6085794 ], [ -122.3292537, 47.608663 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411754, "project_id": 13, "task_id": 307 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329257, 47.6087118 ], [ -122.3291534, 47.6087449 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411755, "project_id": 13, "task_id": 307 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3290874, 47.6087394 ], [ -122.3290051, 47.6086432 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411756, "project_id": 13, "task_id": 307 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3290171, 47.608615 ], [ -122.3291391, 47.6085676 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411757, "project_id": 13, "task_id": 307 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3289661, 47.6086566 ], [ -122.328963, 47.6086275 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411758, "project_id": 13, "task_id": 307 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3290171, 47.608615 ], [ -122.328963, 47.6086275 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411759, "project_id": 13, "task_id": 307 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3290051, 47.6086432 ], [ -122.3289661, 47.6086566 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411760, "project_id": 13, "task_id": 307 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291512, 47.6085401 ], [ -122.3291936, 47.6085516 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411761, "project_id": 13, "task_id": 307 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291778, 47.6085794 ], [ -122.3291936, 47.6085516 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411762, "project_id": 13, "task_id": 307 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291391, 47.6085676 ], [ -122.3291512, 47.6085401 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411763, "project_id": 13, "task_id": 307 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3293035, 47.6086726 ], [ -122.3293088, 47.6087142 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411764, "project_id": 13, "task_id": 307 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329257, 47.6087118 ], [ -122.3293088, 47.6087142 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411765, "project_id": 13, "task_id": 307 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3292537, 47.608663 ], [ -122.3293035, 47.6086726 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411766, "project_id": 13, "task_id": 307 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291355, 47.608765 ], [ -122.3290863, 47.6087529 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411767, "project_id": 13, "task_id": 307 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3290874, 47.6087394 ], [ -122.3290863, 47.6087529 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411768, "project_id": 13, "task_id": 307 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291534, 47.6087449 ], [ -122.3291355, 47.608765 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411769, "project_id": 13, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3269765, 47.6095153 ], [ -122.327063, 47.6095819 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411770, "project_id": 13, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3268507, 47.6096867 ], [ -122.3267844, 47.6095988 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411771, "project_id": 13, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3268113, 47.6095491 ], [ -122.3269088, 47.6095015 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411772, "project_id": 13, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3267435, 47.6095746 ], [ -122.3267515, 47.6095493 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411773, "project_id": 13, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3268113, 47.6095491 ], [ -122.3267515, 47.6095493 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411774, "project_id": 13, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3267844, 47.6095988 ], [ -122.3267435, 47.6095746 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411775, "project_id": 13, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326945, 47.6094813 ], [ -122.3269562, 47.6094931 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411776, "project_id": 13, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3269765, 47.6095153 ], [ -122.3269562, 47.6094931 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411777, "project_id": 13, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3269088, 47.6095015 ], [ -122.326945, 47.6094813 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411778, "project_id": 13, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3270789, 47.6096046 ], [ -122.3268561, 47.6096957 ] ] } }, +{ "type": "Feature", "properties": { "id": 1411780, "project_id": 13, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327063, 47.6095819 ], [ -122.3270789, 47.6096046 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412449, "project_id": 13, "task_id": 513 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3356982, 47.6039002 ], [ -122.3357848, 47.6039886 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412450, "project_id": 13, "task_id": 513 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3357699, 47.6040235 ], [ -122.335584, 47.6041093 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412451, "project_id": 13, "task_id": 513 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355189, 47.6040888 ], [ -122.335427, 47.6039909 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412452, "project_id": 13, "task_id": 513 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354453, 47.6039638 ], [ -122.3356361, 47.6038819 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412453, "project_id": 13, "task_id": 513 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354, 47.6039765 ], [ -122.3354087, 47.6039382 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412454, "project_id": 13, "task_id": 513 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354453, 47.6039638 ], [ -122.3354087, 47.6039382 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412455, "project_id": 13, "task_id": 513 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335427, 47.6039909 ], [ -122.3354, 47.6039765 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412456, "project_id": 13, "task_id": 513 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3356338, 47.603846 ], [ -122.3356832, 47.6038751 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412457, "project_id": 13, "task_id": 513 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3356982, 47.6039002 ], [ -122.3356832, 47.6038751 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412458, "project_id": 13, "task_id": 513 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3356361, 47.6038819 ], [ -122.3356338, 47.603846 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412459, "project_id": 13, "task_id": 513 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358331, 47.6040123 ], [ -122.3358134, 47.6040466 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412460, "project_id": 13, "task_id": 513 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3357699, 47.6040235 ], [ -122.3358134, 47.6040466 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412461, "project_id": 13, "task_id": 513 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3357848, 47.6039886 ], [ -122.3358331, 47.6040123 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412462, "project_id": 13, "task_id": 513 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355883, 47.6041388 ], [ -122.3355451, 47.604133 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412463, "project_id": 13, "task_id": 513 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355189, 47.6040888 ], [ -122.3355451, 47.604133 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412464, "project_id": 13, "task_id": 513 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335584, 47.6041093 ], [ -122.3355883, 47.6041388 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412465, "project_id": 13, "task_id": 217 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3363341, 47.604596 ], [ -122.336425, 47.6047137 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412466, "project_id": 13, "task_id": 217 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336425, 47.6047137 ], [ -122.3362369, 47.6047871 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412467, "project_id": 13, "task_id": 216 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3361479, 47.6047635 ], [ -122.3360696, 47.6046997 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412468, "project_id": 13, "task_id": 216 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360792, 47.6046606 ], [ -122.3362645, 47.6045743 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412469, "project_id": 13, "task_id": 216 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360376, 47.604678 ], [ -122.3360351, 47.6046327 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412470, "project_id": 13, "task_id": 216 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360792, 47.6046606 ], [ -122.3360351, 47.6046327 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412471, "project_id": 13, "task_id": 216 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360696, 47.6046997 ], [ -122.3360376, 47.604678 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412472, "project_id": 13, "task_id": 217 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3362602, 47.6045405 ], [ -122.3363106, 47.6045581 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412473, "project_id": 13, "task_id": 217 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3363341, 47.604596 ], [ -122.3363106, 47.6045581 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412474, "project_id": 13, "task_id": 217 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3362645, 47.6045743 ], [ -122.3362602, 47.6045405 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412475, "project_id": 13, "task_id": 217 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3364555, 47.6047042 ], [ -122.3364425, 47.6047375 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412476, "project_id": 13, "task_id": 217 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336425, 47.6047137 ], [ -122.3364425, 47.6047375 ] ] } }, +{ "type": "Feature", "properties": { "id": 1412477, "project_id": 13, "task_id": 217 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336425, 47.6047137 ], [ -122.3364555, 47.6047042 ] ] } }, +{ "type": "Feature", "properties": { "id": 1413755, "project_id": 13, "task_id": 221 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331758, 47.5982208 ], [ -122.3317557, 47.5983655 ] ] } }, +{ "type": "Feature", "properties": { "id": 1413756, "project_id": 13, "task_id": 221 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3316861, 47.5984106 ], [ -122.3314716, 47.5984355 ] ] } }, +{ "type": "Feature", "properties": { "id": 1413757, "project_id": 13, "task_id": 221 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314097, 47.5983648 ], [ -122.3314551, 47.598229 ] ] } }, +{ "type": "Feature", "properties": { "id": 1413758, "project_id": 13, "task_id": 221 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314429, 47.598414 ], [ -122.3313752, 47.5984212 ] ] } }, +{ "type": "Feature", "properties": { "id": 1413759, "project_id": 13, "task_id": 221 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314097, 47.5983648 ], [ -122.3313752, 47.5984212 ] ] } }, +{ "type": "Feature", "properties": { "id": 1413760, "project_id": 13, "task_id": 221 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314716, 47.5984355 ], [ -122.3314429, 47.598414 ] ] } }, +{ "type": "Feature", "properties": { "id": 1413762, "project_id": 13, "task_id": 221 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314551, 47.598229 ], [ -122.3314771, 47.5982101 ] ] } }, +{ "type": "Feature", "properties": { "id": 1413763, "project_id": 13, "task_id": 221 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3315041, 47.5982125 ], [ -122.331758, 47.5982154 ] ] } }, +{ "type": "Feature", "properties": { "id": 1413764, "project_id": 13, "task_id": 221 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331758, 47.5982208 ], [ -122.331758, 47.5982154 ] ] } }, +{ "type": "Feature", "properties": { "id": 1413766, "project_id": 13, "task_id": 221 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317557, 47.5983745 ], [ -122.3316995, 47.5984106 ] ] } }, +{ "type": "Feature", "properties": { "id": 1413767, "project_id": 13, "task_id": 221 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3316861, 47.5984106 ], [ -122.3316995, 47.5984106 ] ] } }, +{ "type": "Feature", "properties": { "id": 1413768, "project_id": 13, "task_id": 221 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317557, 47.5983655 ], [ -122.3317557, 47.5983745 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422418, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195108, 47.6015955 ], [ -122.3196234, 47.6015978 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422419, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319686, 47.6016505 ], [ -122.31968, 47.6017505 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422420, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3196208, 47.6017918 ], [ -122.3195134, 47.6017942 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422421, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194302, 47.6017487 ], [ -122.319434, 47.6016412 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422422, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194777, 47.6017869 ], [ -122.3194282, 47.6017801 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422423, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194302, 47.6017487 ], [ -122.3194282, 47.6017801 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422424, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195134, 47.6017942 ], [ -122.3194777, 47.6017869 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422425, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194349, 47.6016114 ], [ -122.3194359, 47.6015634 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422426, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195108, 47.6015955 ], [ -122.3194359, 47.6015634 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422427, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319434, 47.6016412 ], [ -122.3194349, 47.6016114 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422428, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3196964, 47.6015946 ], [ -122.3196959, 47.6016097 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422429, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319686, 47.6016505 ], [ -122.3196959, 47.6016097 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422430, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3196234, 47.6015978 ], [ -122.3196964, 47.6015946 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422431, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319686, 47.601788 ], [ -122.3196629, 47.6017914 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422432, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3196208, 47.6017918 ], [ -122.3196629, 47.6017914 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422433, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31968, 47.6017505 ], [ -122.319686, 47.601788 ] ] } }, +{ "type": "Feature", "properties": { "id": 1428615, "project_id": 13, "task_id": 484 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3378607, 47.6030112 ], [ -122.3379249, 47.6030832 ] ] } }, +{ "type": "Feature", "properties": { "id": 1428616, "project_id": 13, "task_id": 486 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3383694, 47.6039445 ], [ -122.3381666, 47.6040377 ] ] } }, +{ "type": "Feature", "properties": { "id": 1428617, "project_id": 13, "task_id": 486 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3380654, 47.6040145 ], [ -122.3379721, 47.6039081 ] ] } }, +{ "type": "Feature", "properties": { "id": 1428618, "project_id": 13, "task_id": 486 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3379875, 47.6038323 ], [ -122.3382025, 47.603754 ] ] } }, +{ "type": "Feature", "properties": { "id": 1428619, "project_id": 13, "task_id": 486 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3379342, 47.6038672 ], [ -122.3379556, 47.6038582 ] ] } }, +{ "type": "Feature", "properties": { "id": 1428620, "project_id": 13, "task_id": 486 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3379875, 47.6038323 ], [ -122.3379556, 47.6038582 ] ] } }, +{ "type": "Feature", "properties": { "id": 1428621, "project_id": 13, "task_id": 486 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3379721, 47.6039081 ], [ -122.3379342, 47.6038672 ] ] } }, +{ "type": "Feature", "properties": { "id": 1428622, "project_id": 13, "task_id": 486 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3382263, 47.6037425 ], [ -122.3384059, 47.6039449 ] ] } }, +{ "type": "Feature", "properties": { "id": 1428623, "project_id": 13, "task_id": 486 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3383694, 47.6039445 ], [ -122.3384059, 47.6039449 ] ] } }, +{ "type": "Feature", "properties": { "id": 1428624, "project_id": 13, "task_id": 486 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3382025, 47.603754 ], [ -122.3382263, 47.6037425 ] ] } }, +{ "type": "Feature", "properties": { "id": 1428625, "project_id": 13, "task_id": 486 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3381325, 47.604057 ], [ -122.3380977, 47.6040498 ] ] } }, +{ "type": "Feature", "properties": { "id": 1428626, "project_id": 13, "task_id": 486 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3380654, 47.6040145 ], [ -122.3380977, 47.6040498 ] ] } }, +{ "type": "Feature", "properties": { "id": 1428627, "project_id": 13, "task_id": 486 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3381666, 47.6040377 ], [ -122.3381325, 47.604057 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435413, "project_id": 13, "task_id": 366 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3281275, 47.6040527 ], [ -122.3282491, 47.6041965 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435414, "project_id": 13, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3287846, 47.6047832 ], [ -122.328878, 47.6048771 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435415, "project_id": 13, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288606, 47.6049223 ], [ -122.3286955, 47.6049812 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435416, "project_id": 13, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3286453, 47.6049811 ], [ -122.3285815, 47.6048981 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435417, "project_id": 13, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3286244, 47.6048638 ], [ -122.3287846, 47.6047832 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435418, "project_id": 13, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3285683, 47.604886 ], [ -122.3286067, 47.6048711 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435419, "project_id": 13, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3286244, 47.6048638 ], [ -122.3286067, 47.6048711 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435420, "project_id": 13, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3285815, 47.6048981 ], [ -122.3285683, 47.604886 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435421, "project_id": 13, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3287655, 47.6047379 ], [ -122.3288135, 47.6047612 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435422, "project_id": 13, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3287846, 47.6047832 ], [ -122.3288135, 47.6047612 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435423, "project_id": 13, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3287846, 47.6047832 ], [ -122.3287655, 47.6047379 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435424, "project_id": 13, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288862, 47.6048843 ], [ -122.3288781, 47.6049114 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435425, "project_id": 13, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288606, 47.6049223 ], [ -122.3288781, 47.6049114 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435426, "project_id": 13, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328878, 47.6048771 ], [ -122.3288862, 47.6048843 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435427, "project_id": 13, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3286709, 47.6050008 ], [ -122.3286593, 47.6049906 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435428, "project_id": 13, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3286453, 47.6049811 ], [ -122.3286593, 47.6049906 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435429, "project_id": 13, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3286955, 47.6049812 ], [ -122.3286709, 47.6050008 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435430, "project_id": 13, "task_id": 173 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3300902, 47.6062 ], [ -122.3300794, 47.6062948 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435431, "project_id": 13, "task_id": 173 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330202, 47.6063373 ], [ -122.3300794, 47.6062948 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435433, "project_id": 13, "task_id": 173 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3300587, 47.6063175 ], [ -122.3300191, 47.606314 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435435, "project_id": 13, "task_id": 173 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3300794, 47.6062948 ], [ -122.3300587, 47.6063175 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435436, "project_id": 13, "task_id": 173 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3300228, 47.6061049 ], [ -122.330115, 47.606162 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435437, "project_id": 13, "task_id": 173 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3300902, 47.6062 ], [ -122.330115, 47.606162 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435439, "project_id": 13, "task_id": 173 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3302913, 47.6063072 ], [ -122.3302538, 47.6063523 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435440, "project_id": 13, "task_id": 173 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330202, 47.6063373 ], [ -122.3302538, 47.6063523 ] ] } }, +{ "type": "Feature", "properties": { "id": 1435442, "project_id": 13, "task_id": 419 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330766, 47.6069378 ], [ -122.330843, 47.6070184 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441833, "project_id": 13, "task_id": 223 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327942, 47.5983785 ], [ -122.3327674, 47.5983785 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441834, "project_id": 13, "task_id": 223 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327621, 47.5983638 ], [ -122.3327674, 47.5983785 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441835, "project_id": 13, "task_id": 223 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332804, 47.5983768 ], [ -122.3327942, 47.5983785 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441836, "project_id": 13, "task_id": 111 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330431, 47.5982117 ], [ -122.3331358, 47.5982007 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441837, "project_id": 13, "task_id": 111 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3332001, 47.5981768 ], [ -122.3331358, 47.5982007 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441838, "project_id": 13, "task_id": 223 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330447, 47.5982463 ], [ -122.3330431, 47.5982117 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441848, "project_id": 13, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275205, 47.598402 ], [ -122.3275284, 47.5983151 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441849, "project_id": 13, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275941, 47.5982637 ], [ -122.3277751, 47.598244 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441850, "project_id": 13, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275199, 47.5982909 ], [ -122.3275539, 47.5982814 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441851, "project_id": 13, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275941, 47.5982637 ], [ -122.3275539, 47.5982814 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441852, "project_id": 13, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275284, 47.5983151 ], [ -122.3275199, 47.5982909 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441854, "project_id": 13, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275205, 47.598402 ], [ -122.3275172, 47.5984186 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441855, "project_id": 13, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277751, 47.598244 ], [ -122.327815, 47.5983022 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441856, "project_id": 13, "task_id": 254 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264962, 47.5982953 ], [ -122.326502, 47.5984202 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441857, "project_id": 13, "task_id": 254 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264667, 47.5984407 ], [ -122.3262837, 47.5984354 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441858, "project_id": 13, "task_id": 254 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262579, 47.59842 ], [ -122.3262544, 47.5982972 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441859, "project_id": 13, "task_id": 254 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262922, 47.5982754 ], [ -122.3264726, 47.5982743 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441860, "project_id": 13, "task_id": 254 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264823, 47.5984335 ], [ -122.3264826, 47.5984462 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441861, "project_id": 13, "task_id": 254 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264667, 47.5984407 ], [ -122.3264826, 47.5984462 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441863, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236515, 47.5984684 ], [ -122.3236515, 47.5984357 ], [ -122.3235973, 47.5984358 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441864, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235971, 47.5984198 ], [ -122.3235973, 47.5984358 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441865, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236683, 47.5984683 ], [ -122.3236515, 47.5984684 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441866, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235944, 47.5982803 ], [ -122.3236468, 47.5982739 ], [ -122.3236506, 47.5982316 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441868, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235946, 47.5982914 ], [ -122.3235944, 47.5982803 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441869, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238834, 47.5982376 ], [ -122.3238839, 47.5982793 ], [ -122.323917, 47.5982801 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441871, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238648, 47.5982426 ], [ -122.3238834, 47.5982376 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441872, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223455, 47.598454 ], [ -122.3223446, 47.5984299 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441873, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322341, 47.5984045 ], [ -122.3223446, 47.5984299 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441874, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322377, 47.5984541 ], [ -122.3223455, 47.598454 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441875, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223259, 47.5982769 ], [ -122.3223457, 47.5982631 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441876, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322388, 47.5982726 ], [ -122.3223457, 47.5982631 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441877, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322337, 47.5983054 ], [ -122.3223259, 47.5982769 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441878, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322578, 47.5982669 ], [ -122.3225782, 47.5982798 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441879, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322578, 47.5982966 ], [ -122.3225782, 47.5982798 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441880, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322543, 47.5982668 ], [ -122.322578, 47.5982669 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441881, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322587, 47.5984361 ], [ -122.3225735, 47.5984479 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441882, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322529, 47.5984401 ], [ -122.3225735, 47.5984479 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441883, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322587, 47.5984045 ], [ -122.322587, 47.5984361 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443143, "project_id": 13, "task_id": 344 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330018, 47.6009826 ], [ -122.3328785, 47.6009628 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443145, "project_id": 13, "task_id": 344 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330206, 47.6008109 ], [ -122.3330394, 47.6009736 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443146, "project_id": 13, "task_id": 344 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3325676, 47.6008001 ], [ -122.3330206, 47.6008019 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443147, "project_id": 13, "task_id": 344 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330206, 47.6008109 ], [ -122.3330206, 47.6008019 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443148, "project_id": 13, "task_id": 344 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3325676, 47.6008091 ], [ -122.3325676, 47.6008001 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443149, "project_id": 13, "task_id": 344 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330394, 47.6009826 ], [ -122.3330152, 47.6009826 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443150, "project_id": 13, "task_id": 344 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330018, 47.6009826 ], [ -122.3330152, 47.6009826 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443151, "project_id": 13, "task_id": 344 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330394, 47.6009736 ], [ -122.3330394, 47.6009826 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443152, "project_id": 13, "task_id": 343 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3328625, 47.6009628 ], [ -122.3325332, 47.6009568 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443154, "project_id": 13, "task_id": 344 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3328785, 47.6009628 ], [ -122.3328625, 47.6009628 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443155, "project_id": 13, "task_id": 441 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327576, 47.6008021 ], [ -122.3277803, 47.6007931 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443156, "project_id": 13, "task_id": 445 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278165, 47.6008103 ], [ -122.327825, 47.6009345 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443157, "project_id": 13, "task_id": 445 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277595, 47.6009692 ], [ -122.3275762, 47.6009855 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443158, "project_id": 13, "task_id": 445 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275442, 47.6009391 ], [ -122.3275515, 47.6008271 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443159, "project_id": 13, "task_id": 445 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275531, 47.6010011 ], [ -122.3275349, 47.600953 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443160, "project_id": 13, "task_id": 445 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275442, 47.6009391 ], [ -122.3275349, 47.600953 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443161, "project_id": 13, "task_id": 445 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275762, 47.6009855 ], [ -122.3275531, 47.6010011 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443162, "project_id": 13, "task_id": 441 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275224, 47.6008136 ], [ -122.327563, 47.6007867 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443163, "project_id": 13, "task_id": 441 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327576, 47.6008021 ], [ -122.327563, 47.6007867 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443164, "project_id": 13, "task_id": 445 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275515, 47.6008271 ], [ -122.3275224, 47.6008136 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443165, "project_id": 13, "task_id": 441 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278011, 47.6007824 ], [ -122.3278257, 47.6008025 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443166, "project_id": 13, "task_id": 445 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278165, 47.6008103 ], [ -122.3278257, 47.6008025 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443167, "project_id": 13, "task_id": 441 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277803, 47.6007931 ], [ -122.3278011, 47.6007824 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443168, "project_id": 13, "task_id": 445 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278257, 47.6009435 ], [ -122.3277899, 47.6009792 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443169, "project_id": 13, "task_id": 445 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277595, 47.6009692 ], [ -122.3277899, 47.6009792 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443170, "project_id": 13, "task_id": 445 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327825, 47.6009345 ], [ -122.3278257, 47.6009435 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443171, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265237, 47.6008244 ], [ -122.32652, 47.6009305 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462890, "project_id": 13, "task_id": 408 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3352319, 47.6050513 ], [ -122.3353263, 47.6051615 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462891, "project_id": 13, "task_id": 408 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3353023, 47.6051851 ], [ -122.3351193, 47.6052944 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462892, "project_id": 13, "task_id": 408 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3350523, 47.6052744 ], [ -122.3349623, 47.6051749 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462893, "project_id": 13, "task_id": 408 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.334977, 47.6051366 ], [ -122.3351725, 47.6050377 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462894, "project_id": 13, "task_id": 408 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3349183, 47.6051669 ], [ -122.3349378, 47.6051351 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462895, "project_id": 13, "task_id": 408 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.334977, 47.6051366 ], [ -122.3349378, 47.6051351 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462896, "project_id": 13, "task_id": 408 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3349623, 47.6051749 ], [ -122.3349183, 47.6051669 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462897, "project_id": 13, "task_id": 408 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3351748, 47.6050125 ], [ -122.3352178, 47.6050255 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462898, "project_id": 13, "task_id": 408 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3352319, 47.6050513 ], [ -122.3352178, 47.6050255 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462899, "project_id": 13, "task_id": 408 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3351725, 47.6050377 ], [ -122.3351748, 47.6050125 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462901, "project_id": 13, "task_id": 410 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3353023, 47.6051851 ], [ -122.3353415, 47.6051901 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462903, "project_id": 13, "task_id": 408 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3350944, 47.6053211 ], [ -122.3350546, 47.6052955 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462904, "project_id": 13, "task_id": 408 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3350523, 47.6052744 ], [ -122.3350546, 47.6052955 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462905, "project_id": 13, "task_id": 408 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3351193, 47.6052944 ], [ -122.3350944, 47.6053211 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462906, "project_id": 13, "task_id": 166 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.334117, 47.6055293 ], [ -122.3341736, 47.6056227 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462907, "project_id": 13, "task_id": 166 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3341715, 47.6056536 ], [ -122.3339843, 47.6057358 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462908, "project_id": 13, "task_id": 166 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3339843, 47.6057358 ], [ -122.3338768, 47.6056202 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462909, "project_id": 13, "task_id": 166 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3338768, 47.6056202 ], [ -122.3340554, 47.6055207 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462910, "project_id": 13, "task_id": 166 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333864, 47.6056127 ], [ -122.3337471, 47.6054926 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462912, "project_id": 13, "task_id": 166 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3338768, 47.6056202 ], [ -122.333864, 47.6056127 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462913, "project_id": 13, "task_id": 166 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333975, 47.6053918 ], [ -122.3340875, 47.6054963 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462914, "project_id": 13, "task_id": 166 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.334117, 47.6055293 ], [ -122.3340875, 47.6054963 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462916, "project_id": 13, "task_id": 166 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33422, 47.6056346 ], [ -122.3342135, 47.6056607 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462917, "project_id": 13, "task_id": 166 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3341715, 47.6056536 ], [ -122.3342135, 47.6056607 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462918, "project_id": 13, "task_id": 166 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3341736, 47.6056227 ], [ -122.33422, 47.6056346 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462921, "project_id": 13, "task_id": 166 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3339843, 47.6057358 ], [ -122.333983, 47.6057547 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462922, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333006, 47.6059836 ], [ -122.3330976, 47.6060876 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462923, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330777, 47.6061189 ], [ -122.3328954, 47.6062095 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462924, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3328404, 47.6062025 ], [ -122.3327543, 47.6060935 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462925, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327645, 47.6060544 ], [ -122.3329586, 47.6059872 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462926, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327251, 47.6060857 ], [ -122.3327247, 47.6060684 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462927, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327645, 47.6060544 ], [ -122.3327247, 47.6060684 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462928, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327543, 47.6060935 ], [ -122.3327251, 47.6060857 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462929, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332973, 47.6059613 ], [ -122.3330034, 47.6059628 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462930, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333006, 47.6059836 ], [ -122.3330034, 47.6059628 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462931, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3329586, 47.6059872 ], [ -122.332973, 47.6059613 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462932, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333117, 47.6061012 ], [ -122.3331354, 47.6061221 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462933, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330777, 47.6061189 ], [ -122.3331354, 47.6061221 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462934, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330976, 47.6060876 ], [ -122.333117, 47.6061012 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462935, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3328707, 47.6062267 ], [ -122.3328475, 47.60622 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462936, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3328404, 47.6062025 ], [ -122.3328475, 47.60622 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462937, "project_id": 13, "task_id": 177 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3328954, 47.6062095 ], [ -122.3328707, 47.6062267 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462938, "project_id": 13, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3318478, 47.6064603 ], [ -122.331978, 47.6065595 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462939, "project_id": 13, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3319633, 47.6065973 ], [ -122.3318006, 47.6066792 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462940, "project_id": 13, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317288, 47.606656 ], [ -122.3316464, 47.606556 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462941, "project_id": 13, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3316378, 47.6064956 ], [ -122.3318085, 47.6064542 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462942, "project_id": 13, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3316192, 47.6065407 ], [ -122.3316237, 47.6065003 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462943, "project_id": 13, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3316378, 47.6064956 ], [ -122.3316237, 47.6065003 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462944, "project_id": 13, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3316464, 47.606556 ], [ -122.3316192, 47.6065407 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462945, "project_id": 13, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3318193, 47.6064284 ], [ -122.3318604, 47.6064472 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462946, "project_id": 13, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3318478, 47.6064603 ], [ -122.3318604, 47.6064472 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462947, "project_id": 13, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3318085, 47.6064542 ], [ -122.3318193, 47.6064284 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462948, "project_id": 13, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3320043, 47.6065744 ], [ -122.3319955, 47.6065972 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462949, "project_id": 13, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3319633, 47.6065973 ], [ -122.3319955, 47.6065972 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462950, "project_id": 13, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331978, 47.6065595 ], [ -122.3320043, 47.6065744 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462951, "project_id": 13, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317898, 47.6066846 ], [ -122.3317523, 47.6066774 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462952, "project_id": 13, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317288, 47.606656 ], [ -122.3317523, 47.6066774 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462953, "project_id": 13, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3318006, 47.6066792 ], [ -122.3317898, 47.6066846 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462954, "project_id": 13, "task_id": 310 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329531, 47.6075987 ], [ -122.3294196, 47.6074753 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462955, "project_id": 13, "task_id": 169 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3285513, 47.6078399 ], [ -122.3286861, 47.6079261 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462957, "project_id": 13, "task_id": 169 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328423, 47.6080653 ], [ -122.3282996, 47.6079307 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462958, "project_id": 13, "task_id": 169 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328324, 47.6079062 ], [ -122.3284523, 47.607834 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462959, "project_id": 13, "task_id": 169 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328324, 47.6079062 ], [ -122.3283135, 47.6079117 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462960, "project_id": 13, "task_id": 169 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3282996, 47.6079307 ], [ -122.3282978, 47.6079227 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462961, "project_id": 13, "task_id": 169 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3285106, 47.6078345 ], [ -122.3285519, 47.6078282 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462962, "project_id": 13, "task_id": 169 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3285513, 47.6078399 ], [ -122.3285519, 47.6078282 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462963, "project_id": 13, "task_id": 169 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3284523, 47.607834 ], [ -122.3285106, 47.6078345 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462964, "project_id": 13, "task_id": 170 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3286941, 47.6079333 ], [ -122.328668, 47.6079685 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462966, "project_id": 13, "task_id": 170 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3286861, 47.6079261 ], [ -122.3286941, 47.6079333 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462967, "project_id": 13, "task_id": 169 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328469, 47.6080797 ], [ -122.3284315, 47.6080725 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462968, "project_id": 13, "task_id": 169 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328423, 47.6080653 ], [ -122.3284315, 47.6080725 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462969, "project_id": 13, "task_id": 169 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328479, 47.6080743 ], [ -122.328469, 47.6080797 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462970, "project_id": 13, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262754, 47.6087824 ], [ -122.3264151, 47.6089006 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462971, "project_id": 13, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3263901, 47.6089261 ], [ -122.3262583, 47.6089954 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462972, "project_id": 13, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3261984, 47.6089842 ], [ -122.3260914, 47.6088675 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462973, "project_id": 13, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3261296, 47.6088113 ], [ -122.3262329, 47.6087701 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462974, "project_id": 13, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260801, 47.6088604 ], [ -122.3260965, 47.6088303 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462975, "project_id": 13, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3261296, 47.6088113 ], [ -122.3260965, 47.6088303 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462976, "project_id": 13, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260914, 47.6088675 ], [ -122.3260801, 47.6088604 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462977, "project_id": 13, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262713, 47.6087565 ], [ -122.3262896, 47.6087667 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462978, "project_id": 13, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262754, 47.6087824 ], [ -122.3262896, 47.6087667 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462979, "project_id": 13, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262329, 47.6087701 ], [ -122.3262713, 47.6087565 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462980, "project_id": 13, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264348, 47.6089029 ], [ -122.3264306, 47.6089357 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462981, "project_id": 13, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3263901, 47.6089261 ], [ -122.3264306, 47.6089357 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462982, "project_id": 13, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264151, 47.6089006 ], [ -122.3264348, 47.6089029 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462983, "project_id": 13, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262579, 47.6090186 ], [ -122.326207, 47.6089969 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462984, "project_id": 13, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3261984, 47.6089842 ], [ -122.326207, 47.6089969 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462985, "project_id": 13, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262583, 47.6089954 ], [ -122.3262579, 47.6090186 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462986, "project_id": 13, "task_id": 298 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325221, 47.6092029 ], [ -122.3253472, 47.609342 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462989, "project_id": 13, "task_id": 298 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249398, 47.6092896 ], [ -122.325146, 47.6092047 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462993, "project_id": 13, "task_id": 298 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251569, 47.6091992 ], [ -122.3252158, 47.6091956 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462994, "project_id": 13, "task_id": 298 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325221, 47.6092029 ], [ -122.3252158, 47.6091956 ] ] } }, +{ "type": "Feature", "properties": { "id": 1462995, "project_id": 13, "task_id": 298 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325146, 47.6092047 ], [ -122.3251569, 47.6091992 ] ] } }, +{ "type": "Feature", "properties": { "id": 1492012, "project_id": 13, "task_id": 71 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277713, 47.5976186 ], [ -122.3276017, 47.5976159 ] ] } }, +{ "type": "Feature", "properties": { "id": 1492013, "project_id": 13, "task_id": 71 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275664, 47.5975873 ], [ -122.3275722, 47.5974702 ] ] } }, +{ "type": "Feature", "properties": { "id": 1492014, "project_id": 13, "task_id": 71 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3276006, 47.5974251 ], [ -122.3277851, 47.5974184 ] ] } }, +{ "type": "Feature", "properties": { "id": 1492015, "project_id": 13, "task_id": 71 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278048, 47.5974423 ], [ -122.3278065, 47.5976351 ] ] } }, +{ "type": "Feature", "properties": { "id": 1492016, "project_id": 13, "task_id": 71 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277713, 47.5976186 ], [ -122.3278065, 47.5976351 ] ] } }, +{ "type": "Feature", "properties": { "id": 1492017, "project_id": 13, "task_id": 71 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277851, 47.5974184 ], [ -122.3278048, 47.5974423 ] ] } }, +{ "type": "Feature", "properties": { "id": 1492018, "project_id": 13, "task_id": 71 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275767, 47.5976277 ], [ -122.3275515, 47.5975986 ] ] } }, +{ "type": "Feature", "properties": { "id": 1492019, "project_id": 13, "task_id": 71 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275664, 47.5975873 ], [ -122.3275515, 47.5975986 ] ] } }, +{ "type": "Feature", "properties": { "id": 1492020, "project_id": 13, "task_id": 71 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3276017, 47.5976159 ], [ -122.3275767, 47.5976277 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495525, "project_id": 13, "task_id": 100 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3365403, 47.6064958 ], [ -122.3366228, 47.6065786 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495526, "project_id": 13, "task_id": 100 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3366019, 47.6066128 ], [ -122.3364328, 47.6067143 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495527, "project_id": 13, "task_id": 100 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3363639, 47.6066987 ], [ -122.3362685, 47.6065961 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495528, "project_id": 13, "task_id": 100 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3362891, 47.6065678 ], [ -122.3364898, 47.6064877 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495529, "project_id": 13, "task_id": 100 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3362413, 47.6065921 ], [ -122.3362526, 47.6065675 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495530, "project_id": 13, "task_id": 100 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3362891, 47.6065678 ], [ -122.3362526, 47.6065675 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495531, "project_id": 13, "task_id": 100 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3362685, 47.6065961 ], [ -122.3362413, 47.6065921 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495532, "project_id": 13, "task_id": 100 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3365057, 47.606463 ], [ -122.3365407, 47.6064672 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495533, "project_id": 13, "task_id": 100 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3365403, 47.6064958 ], [ -122.3365407, 47.6064672 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495534, "project_id": 13, "task_id": 100 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3364898, 47.6064877 ], [ -122.3365057, 47.606463 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495535, "project_id": 13, "task_id": 100 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3366359, 47.6065908 ], [ -122.336636, 47.6066047 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495536, "project_id": 13, "task_id": 100 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3366019, 47.6066128 ], [ -122.336636, 47.6066047 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495537, "project_id": 13, "task_id": 100 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3366228, 47.6065786 ], [ -122.3366359, 47.6065908 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495538, "project_id": 13, "task_id": 100 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3363978, 47.6067236 ], [ -122.3363712, 47.6067161 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495539, "project_id": 13, "task_id": 100 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3363639, 47.6066987 ], [ -122.3363712, 47.6067161 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495540, "project_id": 13, "task_id": 100 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3364328, 47.6067143 ], [ -122.3363978, 47.6067236 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495541, "project_id": 13, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335384, 47.6069544 ], [ -122.3354947, 47.6070711 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495542, "project_id": 13, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354947, 47.6070711 ], [ -122.3352901, 47.607159 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495543, "project_id": 13, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3352901, 47.607159 ], [ -122.335177, 47.607047 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495544, "project_id": 13, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335177, 47.607047 ], [ -122.335384, 47.6069544 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495545, "project_id": 13, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3351435, 47.6070638 ], [ -122.3351563, 47.6070321 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495546, "project_id": 13, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335177, 47.607047 ], [ -122.3351563, 47.6070321 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495547, "project_id": 13, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335177, 47.607047 ], [ -122.3351435, 47.6070638 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495548, "project_id": 13, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335368, 47.6069277 ], [ -122.3354051, 47.6069409 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495549, "project_id": 13, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335384, 47.6069544 ], [ -122.3354051, 47.6069409 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495550, "project_id": 13, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335384, 47.6069544 ], [ -122.335368, 47.6069277 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495551, "project_id": 13, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355118, 47.6070675 ], [ -122.3355055, 47.6070851 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495552, "project_id": 13, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354947, 47.6070711 ], [ -122.3355055, 47.6070851 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495553, "project_id": 13, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354947, 47.6070711 ], [ -122.3355118, 47.6070675 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495554, "project_id": 13, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335299, 47.6071736 ], [ -122.3352488, 47.6071703 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495555, "project_id": 13, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3352901, 47.607159 ], [ -122.3352488, 47.6071703 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495556, "project_id": 13, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3352901, 47.607159 ], [ -122.335299, 47.6071736 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495557, "project_id": 13, "task_id": 331 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343032, 47.6074192 ], [ -122.3344175, 47.6075184 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495558, "project_id": 13, "task_id": 331 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3344036, 47.6075532 ], [ -122.3342107, 47.6076358 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495559, "project_id": 13, "task_id": 328 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33415, 47.6076286 ], [ -122.3340397, 47.607524 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495560, "project_id": 13, "task_id": 331 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340529, 47.6074648 ], [ -122.3342516, 47.6074082 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495561, "project_id": 13, "task_id": 332 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.334016, 47.6075138 ], [ -122.3340354, 47.6074935 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495562, "project_id": 13, "task_id": 328 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340529, 47.6074648 ], [ -122.3340354, 47.6074935 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495563, "project_id": 13, "task_id": 332 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340397, 47.607524 ], [ -122.334016, 47.6075138 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495564, "project_id": 13, "task_id": 331 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.334271, 47.6073894 ], [ -122.3343089, 47.6073987 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495565, "project_id": 13, "task_id": 331 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343032, 47.6074192 ], [ -122.3343089, 47.6073987 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495566, "project_id": 13, "task_id": 331 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3342516, 47.6074082 ], [ -122.334271, 47.6073894 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495567, "project_id": 13, "task_id": 331 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3344321, 47.6075286 ], [ -122.3344305, 47.607551 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495568, "project_id": 13, "task_id": 331 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3344036, 47.6075532 ], [ -122.3344305, 47.607551 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495569, "project_id": 13, "task_id": 331 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3344175, 47.6075184 ], [ -122.3344321, 47.6075286 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495570, "project_id": 13, "task_id": 328 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3341869, 47.6076538 ], [ -122.3341584, 47.6076394 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495571, "project_id": 13, "task_id": 328 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33415, 47.6076286 ], [ -122.3341584, 47.6076394 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495572, "project_id": 13, "task_id": 328 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3342107, 47.6076358 ], [ -122.3341869, 47.6076538 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495573, "project_id": 13, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3331744, 47.6078849 ], [ -122.3332827, 47.6079848 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495574, "project_id": 13, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3332572, 47.6080255 ], [ -122.3331354, 47.6080821 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495575, "project_id": 13, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330594, 47.6080705 ], [ -122.3329438, 47.607986 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495576, "project_id": 13, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3329901, 47.6079293 ], [ -122.3331087, 47.6078769 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495577, "project_id": 13, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3329369, 47.6079734 ], [ -122.3329728, 47.6079502 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495578, "project_id": 13, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3329901, 47.6079293 ], [ -122.3329728, 47.6079502 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495579, "project_id": 13, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3329438, 47.607986 ], [ -122.3329369, 47.6079734 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495580, "project_id": 13, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3331346, 47.6078631 ], [ -122.33318, 47.6078724 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495581, "project_id": 13, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3331744, 47.6078849 ], [ -122.33318, 47.6078724 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495582, "project_id": 13, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3331087, 47.6078769 ], [ -122.3331346, 47.6078631 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495583, "project_id": 13, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3332953, 47.6079923 ], [ -122.3332766, 47.6080186 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495584, "project_id": 13, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3332572, 47.6080255 ], [ -122.3332766, 47.6080186 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495585, "project_id": 13, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3332827, 47.6079848 ], [ -122.3332953, 47.6079923 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495586, "project_id": 13, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330537, 47.6080792 ], [ -122.3330323, 47.6080883 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495587, "project_id": 13, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330594, 47.6080705 ], [ -122.3330323, 47.6080883 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495588, "project_id": 13, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3331354, 47.6080821 ], [ -122.3330537, 47.6080792 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495589, "project_id": 13, "task_id": 308 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3298278, 47.6092777 ], [ -122.329927, 47.609402 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495590, "project_id": 13, "task_id": 308 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3297348, 47.6094675 ], [ -122.3296294, 47.6093728 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495591, "project_id": 13, "task_id": 308 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3296321, 47.6093385 ], [ -122.3298278, 47.6092777 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495592, "project_id": 13, "task_id": 308 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3296214, 47.6093638 ], [ -122.3296187, 47.6093439 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495593, "project_id": 13, "task_id": 308 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3296321, 47.6093385 ], [ -122.3296187, 47.6093439 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495594, "project_id": 13, "task_id": 308 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3296294, 47.6093728 ], [ -122.3296214, 47.6093638 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495595, "project_id": 13, "task_id": 308 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3298068, 47.6092477 ], [ -122.329881, 47.6092479 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495596, "project_id": 13, "task_id": 308 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3298278, 47.6092777 ], [ -122.329881, 47.6092479 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495597, "project_id": 13, "task_id": 308 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3298278, 47.6092777 ], [ -122.3298068, 47.6092477 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495598, "project_id": 13, "task_id": 308 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329927, 47.609402 ], [ -122.3297348, 47.6094675 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495599, "project_id": 13, "task_id": 308 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3297348, 47.6094675 ], [ -122.3297447, 47.6094794 ] ] } }, +{ "type": "Feature", "properties": { "id": 1495600, "project_id": 13, "task_id": 308 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329927, 47.609402 ], [ -122.3299427, 47.6094085 ] ] } }, +{ "type": "Feature", "properties": { "id": 1501215, "project_id": 13, "task_id": 354 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3333425, 47.6030398 ], [ -122.3331406, 47.6031275 ] ] } }, +{ "type": "Feature", "properties": { "id": 1501216, "project_id": 13, "task_id": 354 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330976, 47.6031356 ], [ -122.3330208, 47.6030375 ] ] } }, +{ "type": "Feature", "properties": { "id": 1501218, "project_id": 13, "task_id": 515 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343885, 47.6045638 ], [ -122.3343246, 47.6044807 ] ] } }, +{ "type": "Feature", "properties": { "id": 1501219, "project_id": 13, "task_id": 1 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3371902, 47.6072077 ], [ -122.3372789, 47.6072967 ] ] } }, +{ "type": "Feature", "properties": { "id": 1501221, "project_id": 13, "task_id": 1 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3370185, 47.6074108 ], [ -122.3369243, 47.6073071 ] ] } }, +{ "type": "Feature", "properties": { "id": 1501222, "project_id": 13, "task_id": 1 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3369363, 47.6072705 ], [ -122.3371434, 47.6072008 ] ] } }, +{ "type": "Feature", "properties": { "id": 1501223, "project_id": 13, "task_id": 1 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3368795, 47.6073021 ], [ -122.3368876, 47.6072786 ] ] } }, +{ "type": "Feature", "properties": { "id": 1501224, "project_id": 13, "task_id": 1 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3369363, 47.6072705 ], [ -122.3368876, 47.6072786 ] ] } }, +{ "type": "Feature", "properties": { "id": 1501225, "project_id": 13, "task_id": 1 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3369243, 47.6073071 ], [ -122.3368795, 47.6073021 ] ] } }, +{ "type": "Feature", "properties": { "id": 1501226, "project_id": 13, "task_id": 1 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.337167, 47.6071773 ], [ -122.3371828, 47.6071935 ] ] } }, +{ "type": "Feature", "properties": { "id": 1501227, "project_id": 13, "task_id": 1 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3371902, 47.6072077 ], [ -122.3371828, 47.6071935 ] ] } }, +{ "type": "Feature", "properties": { "id": 1501228, "project_id": 13, "task_id": 1 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3371434, 47.6072008 ], [ -122.337167, 47.6071773 ] ] } }, +{ "type": "Feature", "properties": { "id": 1501229, "project_id": 13, "task_id": 1 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3370377, 47.6074277 ], [ -122.3369921, 47.6074268 ] ] } }, +{ "type": "Feature", "properties": { "id": 1501230, "project_id": 13, "task_id": 1 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3370185, 47.6074108 ], [ -122.3369921, 47.6074268 ] ] } }, +{ "type": "Feature", "properties": { "id": 1503958, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323913, 47.5974489 ], [ -122.323935, 47.5975817 ] ] } }, +{ "type": "Feature", "properties": { "id": 1503959, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323867, 47.5976163 ], [ -122.323671, 47.5976178 ] ] } }, +{ "type": "Feature", "properties": { "id": 1503960, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323594, 47.5975828 ], [ -122.323605, 47.5974487 ] ] } }, +{ "type": "Feature", "properties": { "id": 1503961, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323672, 47.5974089 ], [ -122.32387, 47.5974119 ] ] } }, +{ "type": "Feature", "properties": { "id": 1503962, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323893, 47.5974124 ], [ -122.3238931, 47.5974345 ], [ -122.323911, 47.5974348 ] ] } }, +{ "type": "Feature", "properties": { "id": 1503963, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323913, 47.5974489 ], [ -122.323911, 47.5974348 ] ] } }, +{ "type": "Feature", "properties": { "id": 1503964, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.32387, 47.5974119 ], [ -122.323893, 47.5974124 ] ] } }, +{ "type": "Feature", "properties": { "id": 1503965, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323937, 47.5975938 ], [ -122.3238857, 47.5975947 ], [ -122.3238852, 47.5976163 ] ] } }, +{ "type": "Feature", "properties": { "id": 1503966, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323867, 47.5976163 ], [ -122.3238852, 47.5976163 ] ] } }, +{ "type": "Feature", "properties": { "id": 1503967, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323935, 47.5975817 ], [ -122.323937, 47.5975938 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507656, "project_id": 13, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331056, 47.6038559 ], [ -122.331147, 47.6039476 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507657, "project_id": 13, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3311213, 47.603989 ], [ -122.330954, 47.6040673 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507658, "project_id": 13, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330889, 47.6040575 ], [ -122.330786, 47.6039556 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507659, "project_id": 13, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3308, 47.6039175 ], [ -122.33101, 47.6038564 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507660, "project_id": 13, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3310122, 47.6038372 ], [ -122.3310423, 47.6038418 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507661, "project_id": 13, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331056, 47.6038559 ], [ -122.3310423, 47.6038418 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507662, "project_id": 13, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33101, 47.6038564 ], [ -122.3310122, 47.6038372 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507663, "project_id": 13, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3311647, 47.6039621 ], [ -122.3311503, 47.6039771 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507664, "project_id": 13, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3311213, 47.603989 ], [ -122.3311503, 47.6039771 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507665, "project_id": 13, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331147, 47.6039476 ], [ -122.3311647, 47.6039621 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507667, "project_id": 13, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330889, 47.6040575 ], [ -122.3309037, 47.6040728 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507668, "project_id": 13, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330954, 47.6040673 ], [ -122.3309254, 47.6040809 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507669, "project_id": 13, "task_id": 362 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329708, 47.6043841 ], [ -122.329896, 47.6043139 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507670, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3276941, 47.6052314 ], [ -122.3277933, 47.6053362 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507671, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275672, 47.6054304 ], [ -122.3274895, 47.6053373 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507672, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275048, 47.6053112 ], [ -122.3276566, 47.605253 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507673, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3274449, 47.6053333 ], [ -122.3274476, 47.6052982 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507674, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275048, 47.6053112 ], [ -122.3274476, 47.6052982 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507675, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3274895, 47.6053373 ], [ -122.3274449, 47.6053333 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507676, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3276325, 47.6052278 ], [ -122.3276861, 47.6052223 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507677, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3276941, 47.6052314 ], [ -122.3276861, 47.6052223 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507678, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3276566, 47.605253 ], [ -122.3276325, 47.6052278 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507680, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275672, 47.6054304 ], [ -122.3275732, 47.6054519 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507681, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277933, 47.6053362 ], [ -122.3277987, 47.6053434 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507682, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326579, 47.6057251 ], [ -122.3266501, 47.6058077 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507683, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3266545, 47.6058608 ], [ -122.3265445, 47.6059042 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507684, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264553, 47.6058865 ], [ -122.3263849, 47.6058109 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507685, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3263805, 47.6057572 ], [ -122.3264919, 47.6057115 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507686, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3263367, 47.6057872 ], [ -122.3263517, 47.6057614 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507687, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3263805, 47.6057572 ], [ -122.3263517, 47.6057614 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507688, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3263849, 47.6058109 ], [ -122.3263367, 47.6057872 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507689, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265247, 47.6056941 ], [ -122.3265628, 47.6057047 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507690, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326579, 47.6057251 ], [ -122.3265628, 47.6057047 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507691, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264919, 47.6057115 ], [ -122.3265247, 47.6056941 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507692, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3266778, 47.6058356 ], [ -122.3266726, 47.6058582 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507693, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3266545, 47.6058608 ], [ -122.3266726, 47.6058582 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507694, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3266501, 47.6058077 ], [ -122.3266778, 47.6058356 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507695, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264862, 47.6059385 ], [ -122.3264619, 47.605932 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507696, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264553, 47.6058865 ], [ -122.3264619, 47.605932 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507697, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265445, 47.6059042 ], [ -122.3264862, 47.6059385 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507698, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3243635, 47.6066625 ], [ -122.3244235, 47.6067417 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507699, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3244091, 47.6067663 ], [ -122.324248, 47.606816 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507701, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3241891, 47.6066954 ], [ -122.3243012, 47.6066493 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507703, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3241891, 47.6066954 ], [ -122.32415, 47.6067105 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507704, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3241753, 47.6067358 ], [ -122.32415, 47.6067105 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507705, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3243377, 47.6066339 ], [ -122.3243635, 47.6066625 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507707, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3243012, 47.6066493 ], [ -122.3243377, 47.6066339 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507709, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3244091, 47.6067663 ], [ -122.3244362, 47.606755 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507710, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3244235, 47.6067417 ], [ -122.3244362, 47.606755 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507711, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3242547, 47.6068229 ], [ -122.324248, 47.606816 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507712, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3241753, 47.6067358 ], [ -122.324248, 47.606816 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507713, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324248, 47.606816 ], [ -122.3242547, 47.6068229 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507714, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3221564, 47.6075823 ], [ -122.3222376, 47.6076727 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507715, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3222296, 47.6077046 ], [ -122.322082, 47.6077684 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507716, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220248, 47.6077622 ], [ -122.3219577, 47.6076687 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507717, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219735, 47.607625 ], [ -122.322087, 47.6075787 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507719, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219735, 47.607625 ], [ -122.3219316, 47.6076415 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507720, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219577, 47.6076687 ], [ -122.3219316, 47.6076415 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507721, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220995, 47.6075722 ], [ -122.3221037, 47.6075753 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507722, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3221564, 47.6075823 ], [ -122.322131, 47.6075828 ], [ -122.3221154, 47.6075808 ], [ -122.3221037, 47.6075753 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507723, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322087, 47.6075787 ], [ -122.3220995, 47.6075722 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507724, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3222505, 47.607686 ], [ -122.3222377, 47.607697 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507725, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3222296, 47.6077046 ], [ -122.3222377, 47.607697 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507726, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3222376, 47.6076727 ], [ -122.3222505, 47.607686 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507727, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220682, 47.6077808 ], [ -122.3220405, 47.6077797 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507728, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220248, 47.6077622 ], [ -122.3220405, 47.6077797 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507729, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322082, 47.6077684 ], [ -122.3220682, 47.6077808 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508660, "project_id": 13, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195359, 47.6043241 ], [ -122.319549, 47.6044015 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508661, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194932, 47.60444 ], [ -122.3193633, 47.6044387 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508662, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193235, 47.6044045 ], [ -122.3193333, 47.604317 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508663, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193605, 47.604289 ], [ -122.3194958, 47.6043034 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508664, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193219, 47.604289 ], [ -122.3193294, 47.6042809 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508665, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193605, 47.604289 ], [ -122.3193294, 47.6042809 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508666, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193333, 47.604317 ], [ -122.3193219, 47.604289 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508667, "project_id": 13, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195221, 47.6042938 ], [ -122.3195492, 47.6043015 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508668, "project_id": 13, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195359, 47.6043241 ], [ -122.3195492, 47.6043015 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508669, "project_id": 13, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194958, 47.6043034 ], [ -122.3195221, 47.6042938 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508670, "project_id": 13, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195612, 47.6044282 ], [ -122.3195249, 47.604451 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508671, "project_id": 13, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194932, 47.60444 ], [ -122.3195249, 47.604451 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508672, "project_id": 13, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319549, 47.6044015 ], [ -122.3195612, 47.6044282 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508673, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193313, 47.6044417 ], [ -122.3193162, 47.6044402 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508674, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193235, 47.6044045 ], [ -122.3193162, 47.6044402 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508675, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193633, 47.6044387 ], [ -122.3193313, 47.6044417 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508676, "project_id": 13, "task_id": 41 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195003, 47.6051447 ], [ -122.3194996, 47.6052426 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508677, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194708, 47.6052668 ], [ -122.3193569, 47.6052665 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508678, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193313, 47.6052472 ], [ -122.3193323, 47.6051621 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508679, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193571, 47.6051235 ], [ -122.3194985, 47.6051224 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508680, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193322, 47.6051368 ], [ -122.319332, 47.6051319 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508681, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193571, 47.6051235 ], [ -122.319332, 47.6051319 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508682, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193323, 47.6051621 ], [ -122.3193322, 47.6051368 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508683, "project_id": 13, "task_id": 41 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195235, 47.6051148 ], [ -122.3195232, 47.6051325 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508684, "project_id": 13, "task_id": 41 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195003, 47.6051447 ], [ -122.3195232, 47.6051325 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508685, "project_id": 13, "task_id": 41 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194985, 47.6051224 ], [ -122.3195235, 47.6051148 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508686, "project_id": 13, "task_id": 41 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194992, 47.6052565 ], [ -122.3194979, 47.6052714 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508687, "project_id": 13, "task_id": 41 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194708, 47.6052668 ], [ -122.3194979, 47.6052714 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508688, "project_id": 13, "task_id": 41 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194996, 47.6052426 ], [ -122.3194992, 47.6052565 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508689, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319333, 47.6052722 ], [ -122.3193336, 47.6052681 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508690, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193313, 47.6052472 ], [ -122.3193336, 47.6052681 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508691, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193569, 47.6052665 ], [ -122.319333, 47.6052722 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508703, "project_id": 13, "task_id": 135 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3189565, 47.6026266 ], [ -122.3193197, 47.6026332 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508706, "project_id": 13, "task_id": 135 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193018, 47.602758 ], [ -122.3192726, 47.6027593 ], [ -122.3190795, 47.6027616 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508780, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195554, 47.602662 ], [ -122.3195567, 47.6027345 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508781, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193283, 47.6027463 ], [ -122.3193219, 47.6026542 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508782, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319369, 47.6026281 ], [ -122.3194808, 47.6026216 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508783, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193197, 47.6026332 ], [ -122.3193423, 47.6026286 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508784, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319369, 47.6026281 ], [ -122.3193423, 47.6026286 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508785, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193219, 47.6026542 ], [ -122.3193197, 47.6026332 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508786, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319524, 47.6026219 ], [ -122.3195586, 47.6026425 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508787, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195554, 47.602662 ], [ -122.3195586, 47.6026425 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508788, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194808, 47.6026216 ], [ -122.319524, 47.6026219 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508791, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195567, 47.6027345 ], [ -122.3195588, 47.6027562 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509737, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260066, 47.6051541 ], [ -122.3258884, 47.605197 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509738, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3258283, 47.605186 ], [ -122.3257445, 47.6050492 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509739, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3258609, 47.605001 ], [ -122.3260177, 47.6051085 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509740, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3257445, 47.6050492 ], [ -122.3258609, 47.605001 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509741, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3258609, 47.605001 ], [ -122.3258866, 47.6049807 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509742, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3257445, 47.6050492 ], [ -122.3257159, 47.6050568 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509743, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260443, 47.6051085 ], [ -122.3260408, 47.6051522 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509744, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260066, 47.6051541 ], [ -122.3260408, 47.6051522 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509745, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260177, 47.6051085 ], [ -122.3260443, 47.6051085 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509746, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3258714, 47.6052132 ], [ -122.3258288, 47.6051977 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509747, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3258283, 47.605186 ], [ -122.3258288, 47.6051977 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509748, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3258884, 47.605197 ], [ -122.3258714, 47.6052132 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509749, "project_id": 13, "task_id": 168 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327899, 47.6071356 ], [ -122.3279714, 47.6072493 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509750, "project_id": 13, "task_id": 168 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3279529, 47.607285 ], [ -122.3278314, 47.6073255 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509751, "project_id": 13, "task_id": 168 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277595, 47.6073194 ], [ -122.3276339, 47.6072386 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509752, "project_id": 13, "task_id": 168 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3276473, 47.6072025 ], [ -122.327845, 47.6071266 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509753, "project_id": 13, "task_id": 168 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3276258, 47.6072314 ], [ -122.3276366, 47.6072079 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509754, "project_id": 13, "task_id": 168 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3276473, 47.6072025 ], [ -122.3276366, 47.6072079 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509755, "project_id": 13, "task_id": 168 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3276339, 47.6072386 ], [ -122.3276258, 47.6072314 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509756, "project_id": 13, "task_id": 168 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278564, 47.607123 ], [ -122.3278939, 47.6071284 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509757, "project_id": 13, "task_id": 168 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327899, 47.6071356 ], [ -122.3278939, 47.6071284 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509758, "project_id": 13, "task_id": 168 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327845, 47.6071266 ], [ -122.3278564, 47.607123 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509759, "project_id": 13, "task_id": 168 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3280106, 47.607259 ], [ -122.3279965, 47.6072771 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509760, "project_id": 13, "task_id": 168 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3279529, 47.607285 ], [ -122.3279965, 47.6072771 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509761, "project_id": 13, "task_id": 168 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3279714, 47.6072493 ], [ -122.3280106, 47.607259 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509762, "project_id": 13, "task_id": 168 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278119, 47.6073487 ], [ -122.327779, 47.6073485 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509763, "project_id": 13, "task_id": 168 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277595, 47.6073194 ], [ -122.327779, 47.6073485 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509764, "project_id": 13, "task_id": 168 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278314, 47.6073255 ], [ -122.3278119, 47.6073487 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511688, "project_id": 13, "task_id": 135 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3189717, 47.6026479 ], [ -122.3190244, 47.6027069 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511689, "project_id": 13, "task_id": 138 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3189173, 47.6026037 ], [ -122.3189565, 47.6026266 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511690, "project_id": 13, "task_id": 138 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3189717, 47.6026479 ], [ -122.3189565, 47.6026266 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511692, "project_id": 13, "task_id": 135 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3190502, 47.6027335 ], [ -122.3190795, 47.6027616 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511694, "project_id": 13, "task_id": 135 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3190244, 47.6027069 ], [ -122.3190502, 47.6027335 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511695, "project_id": 13, "task_id": 138 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3188753, 47.6028355 ], [ -122.3187193, 47.6026956 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511699, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3204661, 47.6044092 ], [ -122.3204242, 47.6043561 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511701, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3203737, 47.6043137 ], [ -122.3203599, 47.6042815 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511703, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3204242, 47.6043561 ], [ -122.3203737, 47.6043137 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511704, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3205567, 47.6041954 ], [ -122.3206238, 47.6042632 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511707, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3205634, 47.604478 ], [ -122.320522, 47.6044453 ], [ -122.3204962, 47.6044329 ], [ -122.320456, 47.6044261 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511708, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3204661, 47.6044092 ], [ -122.320456, 47.6044261 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511710, "project_id": 13, "task_id": 266 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3213934, 47.6050972 ], [ -122.321216, 47.6051636 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511712, "project_id": 13, "task_id": 266 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3213199, 47.6049541 ], [ -122.321404, 47.6050627 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511713, "project_id": 13, "task_id": 266 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3212711, 47.6049394 ], [ -122.3213199, 47.6049314 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511714, "project_id": 13, "task_id": 266 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3213199, 47.6049541 ], [ -122.3213199, 47.6049314 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511716, "project_id": 13, "task_id": 266 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214243, 47.6050723 ], [ -122.3214155, 47.6050952 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511717, "project_id": 13, "task_id": 266 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3213934, 47.6050972 ], [ -122.3214155, 47.6050952 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511718, "project_id": 13, "task_id": 266 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321404, 47.6050627 ], [ -122.3214243, 47.6050723 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511719, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3211996, 47.605171 ], [ -122.3209159, 47.6048634 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511721, "project_id": 13, "task_id": 266 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321216, 47.6051636 ], [ -122.3211996, 47.605171 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511722, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226027, 47.6063613 ], [ -122.322728, 47.6065355 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511723, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3224815, 47.6066156 ], [ -122.3223587, 47.6064522 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511724, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223581, 47.6064161 ], [ -122.3225372, 47.6063461 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511725, "project_id": 13, "task_id": 159 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223337, 47.6064507 ], [ -122.3223325, 47.6064166 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511726, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223581, 47.6064161 ], [ -122.3223325, 47.6064166 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511727, "project_id": 13, "task_id": 159 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223587, 47.6064522 ], [ -122.3223337, 47.6064507 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511728, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225611, 47.6063333 ], [ -122.322598, 47.6063381 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511729, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226027, 47.6063613 ], [ -122.322598, 47.6063381 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511730, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225372, 47.6063461 ], [ -122.3225611, 47.6063333 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511731, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322728, 47.6065355 ], [ -122.3225282, 47.6066218 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511732, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3224815, 47.6066156 ], [ -122.322474, 47.6066287 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511733, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322728, 47.6065355 ], [ -122.3227562, 47.6065115 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511734, "project_id": 13, "task_id": 296 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324584, 47.6085348 ], [ -122.3246581, 47.6086227 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511735, "project_id": 13, "task_id": 296 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324658, 47.6086543 ], [ -122.3244445, 47.6087255 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511736, "project_id": 13, "task_id": 296 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3244445, 47.6087255 ], [ -122.3243233, 47.608628 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511737, "project_id": 13, "task_id": 296 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324343, 47.608592 ], [ -122.324515, 47.6085185 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511738, "project_id": 13, "task_id": 296 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3242781, 47.6086055 ], [ -122.3243282, 47.608597 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511739, "project_id": 13, "task_id": 296 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324343, 47.608592 ], [ -122.3243282, 47.608597 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511740, "project_id": 13, "task_id": 296 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3243233, 47.608628 ], [ -122.3242781, 47.6086055 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511741, "project_id": 13, "task_id": 296 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324529, 47.6085071 ], [ -122.324576, 47.6085192 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511742, "project_id": 13, "task_id": 296 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324584, 47.6085348 ], [ -122.324576, 47.6085192 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511743, "project_id": 13, "task_id": 296 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324515, 47.6085185 ], [ -122.324529, 47.6085071 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511744, "project_id": 13, "task_id": 296 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3246775, 47.6086272 ], [ -122.3246695, 47.6086507 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511745, "project_id": 13, "task_id": 294 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324658, 47.6086543 ], [ -122.3246695, 47.6086507 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511746, "project_id": 13, "task_id": 296 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3246581, 47.6086227 ], [ -122.3246775, 47.6086272 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511747, "project_id": 13, "task_id": 296 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3244443, 47.6087447 ], [ -122.3244095, 47.6087375 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511748, "project_id": 13, "task_id": 296 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3244445, 47.6087255 ], [ -122.3244095, 47.6087375 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511749, "project_id": 13, "task_id": 296 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3244445, 47.6087255 ], [ -122.3244443, 47.6087447 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518048, "project_id": 13, "task_id": 88 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360438, 47.6076689 ], [ -122.3361485, 47.6077961 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518049, "project_id": 13, "task_id": 88 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3361485, 47.6077961 ], [ -122.3359521, 47.6078726 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518050, "project_id": 13, "task_id": 88 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3359521, 47.6078726 ], [ -122.3358377, 47.6077554 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518051, "project_id": 13, "task_id": 88 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358377, 47.6077554 ], [ -122.3360438, 47.6076689 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518052, "project_id": 13, "task_id": 88 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3357934, 47.6077701 ], [ -122.3357986, 47.6077425 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518053, "project_id": 13, "task_id": 88 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358377, 47.6077554 ], [ -122.3357986, 47.6077425 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518054, "project_id": 13, "task_id": 88 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358377, 47.6077554 ], [ -122.3357934, 47.6077701 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518055, "project_id": 13, "task_id": 88 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360189, 47.607638 ], [ -122.3360663, 47.6076532 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518056, "project_id": 13, "task_id": 88 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360438, 47.6076689 ], [ -122.3360663, 47.6076532 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518057, "project_id": 13, "task_id": 88 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360438, 47.6076689 ], [ -122.3360189, 47.607638 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518058, "project_id": 13, "task_id": 88 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3361743, 47.6077905 ], [ -122.3361836, 47.6078256 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518059, "project_id": 13, "task_id": 88 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3361485, 47.6077961 ], [ -122.3361836, 47.6078256 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518060, "project_id": 13, "task_id": 88 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3361485, 47.6077961 ], [ -122.3361743, 47.6077905 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518061, "project_id": 13, "task_id": 88 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3359577, 47.6078847 ], [ -122.3358999, 47.6078851 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518062, "project_id": 13, "task_id": 88 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3359521, 47.6078726 ], [ -122.3358999, 47.6078851 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518063, "project_id": 13, "task_id": 88 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3359521, 47.6078726 ], [ -122.3359577, 47.6078847 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518064, "project_id": 13, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3349627, 47.6081246 ], [ -122.3350601, 47.6082318 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518065, "project_id": 13, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3350572, 47.6082641 ], [ -122.3348693, 47.6083592 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518066, "project_id": 13, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3347836, 47.6083351 ], [ -122.3346896, 47.6082215 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518067, "project_id": 13, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3346993, 47.6081688 ], [ -122.3348961, 47.6081186 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518068, "project_id": 13, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3346733, 47.608212 ], [ -122.334679, 47.6081834 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518069, "project_id": 13, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3346993, 47.6081688 ], [ -122.334679, 47.6081834 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518070, "project_id": 13, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3346896, 47.6082215 ], [ -122.3346733, 47.608212 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518071, "project_id": 13, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3349273, 47.6081025 ], [ -122.3349505, 47.6081078 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518072, "project_id": 13, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3349627, 47.6081246 ], [ -122.3349505, 47.6081078 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518073, "project_id": 13, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3348961, 47.6081186 ], [ -122.3349273, 47.6081025 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518074, "project_id": 13, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3350731, 47.6082305 ], [ -122.335071, 47.6082424 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518075, "project_id": 13, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3350572, 47.6082641 ], [ -122.335071, 47.6082424 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518076, "project_id": 13, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3350601, 47.6082318 ], [ -122.3350731, 47.6082305 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518077, "project_id": 13, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3348474, 47.6083622 ], [ -122.3347921, 47.6083454 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518078, "project_id": 13, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3347836, 47.6083351 ], [ -122.3347921, 47.6083454 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518079, "project_id": 13, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3348693, 47.6083592 ], [ -122.3348474, 47.6083622 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518080, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3337876, 47.6085741 ], [ -122.3339518, 47.6086911 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518081, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3339347, 47.6087829 ], [ -122.3337861, 47.6088033 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518082, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3337033, 47.6087845 ], [ -122.3336214, 47.6086994 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518083, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3336384, 47.6086405 ], [ -122.3337876, 47.6085741 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518084, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3335748, 47.6086809 ], [ -122.3335738, 47.6086536 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518085, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3336384, 47.6086405 ], [ -122.3335738, 47.6086536 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518086, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3336214, 47.6086994 ], [ -122.3335748, 47.6086809 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518088, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3337876, 47.6085741 ], [ -122.3337793, 47.6085614 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518089, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3337876, 47.6085741 ], [ -122.3337793, 47.6085614 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518090, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3337448, 47.6088088 ], [ -122.3337049, 47.6088097 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518091, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3337033, 47.6087845 ], [ -122.3337049, 47.6088097 ] ] } }, +{ "type": "Feature", "properties": { "id": 1518092, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3337861, 47.6088033 ], [ -122.3337448, 47.6088088 ] ] } }, +{ "type": "Feature", "properties": { "id": 1524686, "project_id": 13, "task_id": 78 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265158, 47.5957549 ], [ -122.3265177, 47.5959302 ] ] } }, +{ "type": "Feature", "properties": { "id": 1524687, "project_id": 13, "task_id": 78 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326482, 47.595952 ], [ -122.3263017, 47.5959503 ] ] } }, +{ "type": "Feature", "properties": { "id": 1524688, "project_id": 13, "task_id": 78 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262639, 47.5959279 ], [ -122.326256, 47.5957585 ] ] } }, +{ "type": "Feature", "properties": { "id": 1524689, "project_id": 13, "task_id": 78 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262925, 47.5957344 ], [ -122.3264836, 47.5957302 ] ] } }, +{ "type": "Feature", "properties": { "id": 1524690, "project_id": 13, "task_id": 78 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262355, 47.5957401 ], [ -122.3262684, 47.595713 ] ] } }, +{ "type": "Feature", "properties": { "id": 1524691, "project_id": 13, "task_id": 78 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262925, 47.5957344 ], [ -122.3262684, 47.595713 ] ] } }, +{ "type": "Feature", "properties": { "id": 1524692, "project_id": 13, "task_id": 78 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326256, 47.5957585 ], [ -122.3262355, 47.5957401 ] ] } }, +{ "type": "Feature", "properties": { "id": 1524693, "project_id": 13, "task_id": 78 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265011, 47.595717 ], [ -122.3265253, 47.595735 ] ] } }, +{ "type": "Feature", "properties": { "id": 1524694, "project_id": 13, "task_id": 78 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265158, 47.5957549 ], [ -122.3265253, 47.595735 ] ] } }, +{ "type": "Feature", "properties": { "id": 1524695, "project_id": 13, "task_id": 78 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264836, 47.5957302 ], [ -122.3265011, 47.595717 ] ] } }, +{ "type": "Feature", "properties": { "id": 1524696, "project_id": 13, "task_id": 78 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265058, 47.5959549 ], [ -122.3264958, 47.595952 ] ] } }, +{ "type": "Feature", "properties": { "id": 1524697, "project_id": 13, "task_id": 78 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326482, 47.595952 ], [ -122.3264958, 47.595952 ] ] } }, +{ "type": "Feature", "properties": { "id": 1524698, "project_id": 13, "task_id": 78 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265177, 47.5959302 ], [ -122.3265058, 47.5959549 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529865, "project_id": 13, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333453, 47.604812 ], [ -122.333537, 47.6049347 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529866, "project_id": 13, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333537, 47.6049347 ], [ -122.33335, 47.6050182 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529867, "project_id": 13, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333297, 47.6050107 ], [ -122.333215, 47.6048952 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529868, "project_id": 13, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333215, 47.6048952 ], [ -122.333404, 47.6048026 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529872, "project_id": 13, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3334217, 47.6047784 ], [ -122.3334623, 47.6047851 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529873, "project_id": 13, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333453, 47.604812 ], [ -122.3334623, 47.6047851 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529874, "project_id": 13, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333404, 47.6048026 ], [ -122.3334217, 47.6047784 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529875, "project_id": 13, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3333347, 47.6050356 ], [ -122.3333133, 47.6050304 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529876, "project_id": 13, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333297, 47.6050107 ], [ -122.3333133, 47.6050304 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529877, "project_id": 13, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33335, 47.6050182 ], [ -122.3333347, 47.6050356 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529878, "project_id": 13, "task_id": 258 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33235, 47.6052769 ], [ -122.3324336, 47.6053821 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529879, "project_id": 13, "task_id": 258 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3324246, 47.6054133 ], [ -122.3322403, 47.6054826 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529880, "project_id": 13, "task_id": 384 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3321882, 47.6054823 ], [ -122.332103, 47.6053759 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529881, "project_id": 13, "task_id": 384 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332099, 47.6053364 ], [ -122.3323106, 47.6052808 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529882, "project_id": 13, "task_id": 384 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3320649, 47.6053698 ], [ -122.3320654, 47.6053481 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529883, "project_id": 13, "task_id": 384 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332099, 47.6053364 ], [ -122.3320654, 47.6053481 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529884, "project_id": 13, "task_id": 384 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332103, 47.6053759 ], [ -122.3320649, 47.6053698 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529885, "project_id": 13, "task_id": 384 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3323263, 47.6052572 ], [ -122.3323475, 47.6052578 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529886, "project_id": 13, "task_id": 384 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33235, 47.6052769 ], [ -122.3323475, 47.6052578 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529887, "project_id": 13, "task_id": 384 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3323106, 47.6052808 ], [ -122.3323263, 47.6052572 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529888, "project_id": 13, "task_id": 258 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3324659, 47.6053876 ], [ -122.3324695, 47.6054081 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529889, "project_id": 13, "task_id": 258 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3324246, 47.6054133 ], [ -122.3324695, 47.6054081 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529890, "project_id": 13, "task_id": 258 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3324336, 47.6053821 ], [ -122.3324659, 47.6053876 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529891, "project_id": 13, "task_id": 258 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3322182, 47.6055135 ], [ -122.3321861, 47.605508 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529892, "project_id": 13, "task_id": 384 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3321882, 47.6054823 ], [ -122.3321861, 47.605508 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529893, "project_id": 13, "task_id": 258 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3322403, 47.6054826 ], [ -122.3322182, 47.6055135 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529894, "project_id": 13, "task_id": 395 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3311894, 47.6057488 ], [ -122.3313145, 47.6058534 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529895, "project_id": 13, "task_id": 395 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3312989, 47.6058869 ], [ -122.3311139, 47.6059446 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529896, "project_id": 13, "task_id": 395 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3311139, 47.6059446 ], [ -122.3310109, 47.6058216 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529897, "project_id": 13, "task_id": 395 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3310109, 47.6058216 ], [ -122.3311894, 47.6057488 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529898, "project_id": 13, "task_id": 395 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3309713, 47.6058326 ], [ -122.3309795, 47.6057895 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529899, "project_id": 13, "task_id": 395 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3310109, 47.6058216 ], [ -122.3309795, 47.6057895 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529900, "project_id": 13, "task_id": 395 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3310109, 47.6058216 ], [ -122.3309713, 47.6058326 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529901, "project_id": 13, "task_id": 395 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3311805, 47.6057219 ], [ -122.331226, 47.605727 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529902, "project_id": 13, "task_id": 395 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3311894, 47.6057488 ], [ -122.331226, 47.605727 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529903, "project_id": 13, "task_id": 395 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3311894, 47.6057488 ], [ -122.3311805, 47.6057219 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529904, "project_id": 13, "task_id": 395 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3313507, 47.6058633 ], [ -122.331331, 47.6058803 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529905, "project_id": 13, "task_id": 395 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3312989, 47.6058869 ], [ -122.331331, 47.6058803 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529906, "project_id": 13, "task_id": 395 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3313145, 47.6058534 ], [ -122.3313507, 47.6058633 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529907, "project_id": 13, "task_id": 395 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3311296, 47.6059558 ], [ -122.3310929, 47.6059478 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529908, "project_id": 13, "task_id": 395 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3311139, 47.6059446 ], [ -122.3310929, 47.6059478 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529909, "project_id": 13, "task_id": 395 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3311139, 47.6059446 ], [ -122.3311296, 47.6059558 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529941, "project_id": 13, "task_id": 12 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3287401, 47.6067717 ], [ -122.3287319, 47.6067345 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529942, "project_id": 13, "task_id": 12 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3287896, 47.6067853 ], [ -122.3287319, 47.6067345 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529944, "project_id": 13, "task_id": 12 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288311, 47.6066026 ], [ -122.329, 47.6067815 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529946, "project_id": 13, "task_id": 12 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288204, 47.6066062 ], [ -122.3288311, 47.6066026 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529947, "project_id": 13, "task_id": 12 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3289273, 47.6069018 ], [ -122.3289115, 47.6068664 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529948, "project_id": 13, "task_id": 12 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288594, 47.6068587 ], [ -122.3289115, 47.6068664 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529950, "project_id": 13, "task_id": 295 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325677, 47.6080865 ], [ -122.3257756, 47.6081706 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529951, "project_id": 13, "task_id": 295 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3257648, 47.6082067 ], [ -122.3256114, 47.6082535 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529952, "project_id": 13, "task_id": 295 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3255297, 47.608248 ], [ -122.3254886, 47.6081628 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529953, "project_id": 13, "task_id": 295 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3254943, 47.6081273 ], [ -122.325606, 47.6080809 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529954, "project_id": 13, "task_id": 295 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325411, 47.6081561 ], [ -122.3254415, 47.608132 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529955, "project_id": 13, "task_id": 295 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3254943, 47.6081273 ], [ -122.3254415, 47.608132 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529956, "project_id": 13, "task_id": 295 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3254886, 47.6081628 ], [ -122.325411, 47.6081561 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529957, "project_id": 13, "task_id": 295 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3256255, 47.6080585 ], [ -122.3256579, 47.608054 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529958, "project_id": 13, "task_id": 295 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325677, 47.6080865 ], [ -122.3256579, 47.608054 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529959, "project_id": 13, "task_id": 295 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325606, 47.6080809 ], [ -122.3256255, 47.6080585 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529960, "project_id": 13, "task_id": 295 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3257836, 47.6081778 ], [ -122.3257756, 47.6082013 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529961, "project_id": 13, "task_id": 295 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3257648, 47.6082067 ], [ -122.3257756, 47.6082013 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529962, "project_id": 13, "task_id": 295 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3257756, 47.6081706 ], [ -122.3257836, 47.6081778 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529963, "project_id": 13, "task_id": 295 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3255978, 47.6082642 ], [ -122.3255461, 47.6082731 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529964, "project_id": 13, "task_id": 295 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3255297, 47.608248 ], [ -122.3255461, 47.6082731 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529965, "project_id": 13, "task_id": 295 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3256114, 47.6082535 ], [ -122.3255978, 47.6082642 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530500, "project_id": 13, "task_id": 505 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331471, 47.6026757 ], [ -122.3315837, 47.6027961 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530501, "project_id": 13, "task_id": 505 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3315837, 47.6027961 ], [ -122.3313789, 47.6028803 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530502, "project_id": 13, "task_id": 505 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3313789, 47.6028803 ], [ -122.3312615, 47.6027472 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530503, "project_id": 13, "task_id": 505 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3312615, 47.6027472 ], [ -122.331471, 47.6026757 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530504, "project_id": 13, "task_id": 505 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3312331, 47.6027634 ], [ -122.3312326, 47.6027343 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530505, "project_id": 13, "task_id": 505 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3312615, 47.6027472 ], [ -122.3312326, 47.6027343 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530506, "project_id": 13, "task_id": 505 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3312615, 47.6027472 ], [ -122.3312331, 47.6027634 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530507, "project_id": 13, "task_id": 505 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314552, 47.6026324 ], [ -122.3314812, 47.6026575 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530508, "project_id": 13, "task_id": 505 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331471, 47.6026757 ], [ -122.3314812, 47.6026575 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530510, "project_id": 13, "task_id": 505 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3313763, 47.6028952 ], [ -122.3313522, 47.602906 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530512, "project_id": 13, "task_id": 505 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3313789, 47.6028803 ], [ -122.3313763, 47.6028952 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530513, "project_id": 13, "task_id": 533 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330386, 47.6031378 ], [ -122.330484, 47.6032335 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530514, "project_id": 13, "task_id": 533 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330459, 47.6032681 ], [ -122.330274, 47.6033489 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530515, "project_id": 13, "task_id": 533 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3302232, 47.6033485 ], [ -122.3300941, 47.6032116 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530516, "project_id": 13, "task_id": 533 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301037, 47.6031853 ], [ -122.330311, 47.6031039 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530517, "project_id": 13, "task_id": 533 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3300941, 47.6032116 ], [ -122.3300837, 47.6032019 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530518, "project_id": 13, "task_id": 530 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301037, 47.6031853 ], [ -122.3300837, 47.6032019 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530521, "project_id": 13, "task_id": 533 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330386, 47.6031378 ], [ -122.3303741, 47.6031249 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530522, "project_id": 13, "task_id": 533 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330311, 47.6031039 ], [ -122.330343, 47.6030868 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530523, "project_id": 13, "task_id": 533 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3305128, 47.6032549 ], [ -122.3304887, 47.6032657 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530524, "project_id": 13, "task_id": 533 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330459, 47.6032681 ], [ -122.3304887, 47.6032657 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530525, "project_id": 13, "task_id": 533 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330484, 47.6032335 ], [ -122.3305128, 47.6032549 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530527, "project_id": 13, "task_id": 533 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3302232, 47.6033485 ], [ -122.330217, 47.603376 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530528, "project_id": 13, "task_id": 533 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330274, 47.6033489 ], [ -122.330217, 47.603376 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530529, "project_id": 13, "task_id": 534 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329247, 47.6035728 ], [ -122.329375, 47.6037057 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530530, "project_id": 13, "task_id": 534 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329362, 47.6037402 ], [ -122.3291865, 47.6038052 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530531, "project_id": 13, "task_id": 534 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329137, 47.6038004 ], [ -122.329018, 47.6036689 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530532, "project_id": 13, "task_id": 534 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329023, 47.6036443 ], [ -122.329212, 47.6035664 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530533, "project_id": 13, "task_id": 534 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3289959, 47.6036722 ], [ -122.3290147, 47.603662 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530534, "project_id": 13, "task_id": 534 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329023, 47.6036443 ], [ -122.3290147, 47.603662 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530535, "project_id": 13, "task_id": 534 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329018, 47.6036689 ], [ -122.3289959, 47.6036722 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530536, "project_id": 13, "task_id": 534 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3292479, 47.6035611 ], [ -122.3292612, 47.6035562 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530537, "project_id": 13, "task_id": 534 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329247, 47.6035728 ], [ -122.3292612, 47.6035562 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530538, "project_id": 13, "task_id": 534 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329212, 47.6035664 ], [ -122.3292479, 47.6035611 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530539, "project_id": 13, "task_id": 534 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329406, 47.603712 ], [ -122.3293979, 47.6037337 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530540, "project_id": 13, "task_id": 534 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329362, 47.6037402 ], [ -122.3293979, 47.6037337 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530541, "project_id": 13, "task_id": 534 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329375, 47.6037057 ], [ -122.329406, 47.603712 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530542, "project_id": 13, "task_id": 534 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291755, 47.6038313 ], [ -122.3291352, 47.6038241 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530543, "project_id": 13, "task_id": 534 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329137, 47.6038004 ], [ -122.3291352, 47.6038241 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530544, "project_id": 13, "task_id": 534 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291865, 47.6038052 ], [ -122.3291755, 47.6038313 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530546, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327141, 47.6046801 ], [ -122.326969, 47.6047364 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530547, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326969, 47.6047364 ], [ -122.3268171, 47.6045994 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530548, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3268389, 47.6045693 ], [ -122.3269883, 47.604509 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530549, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3268017, 47.6045848 ], [ -122.3268193, 47.604577 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530550, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3268389, 47.6045693 ], [ -122.3268193, 47.604577 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530551, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3268171, 47.6045994 ], [ -122.3268017, 47.6045848 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530552, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3269964, 47.6045069 ], [ -122.327006, 47.604503 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530554, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3269883, 47.604509 ], [ -122.3269964, 47.6045069 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530556, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327141, 47.6046801 ], [ -122.3271552, 47.6046747 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530558, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3269628, 47.6047475 ], [ -122.3269445, 47.6047416 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530559, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326969, 47.6047364 ], [ -122.3269445, 47.6047416 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530560, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326969, 47.6047364 ], [ -122.3269628, 47.6047475 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530561, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3237097, 47.6059183 ], [ -122.323799, 47.606036 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530562, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3237665, 47.6060677 ], [ -122.323664, 47.6061146 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530563, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323627, 47.6061087 ], [ -122.3235199, 47.6060062 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530564, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235369, 47.605976 ], [ -122.3236461, 47.6059106 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530565, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3234561, 47.6059932 ], [ -122.3234629, 47.6059797 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530566, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235369, 47.605976 ], [ -122.3234629, 47.6059797 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530567, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235199, 47.6060062 ], [ -122.3234561, 47.6059932 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530568, "project_id": 13, "task_id": 401 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238162, 47.6060484 ], [ -122.3238328, 47.6060776 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530569, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3237665, 47.6060677 ], [ -122.3238328, 47.6060776 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530570, "project_id": 13, "task_id": 407 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323799, 47.606036 ], [ -122.3238162, 47.6060484 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530571, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236403, 47.6061431 ], [ -122.3236207, 47.606141 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530572, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323627, 47.6061087 ], [ -122.3236207, 47.606141 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530573, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323664, 47.6061146 ], [ -122.3236403, 47.6061431 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530574, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214443, 47.606872 ], [ -122.3215593, 47.6069691 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530575, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3215596, 47.607 ], [ -122.321446, 47.607049 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530576, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321446, 47.607049 ], [ -122.3213164, 47.6069099 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530577, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3213164, 47.6069099 ], [ -122.3214443, 47.606872 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530578, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3212772, 47.6069188 ], [ -122.3212582, 47.6068973 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530579, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3213164, 47.6069099 ], [ -122.3212582, 47.6068973 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530580, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3213164, 47.6069099 ], [ -122.3212772, 47.6069188 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530581, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214337, 47.6068263 ], [ -122.3214531, 47.6068469 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530582, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214443, 47.606872 ], [ -122.3214531, 47.6068469 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530583, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214443, 47.606872 ], [ -122.3214337, 47.6068263 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530584, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321599, 47.6069692 ], [ -122.3215687, 47.6069821 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530585, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3215596, 47.607 ], [ -122.3215687, 47.6069821 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530586, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3215593, 47.6069691 ], [ -122.321599, 47.6069692 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530587, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214137, 47.6070759 ], [ -122.3214047, 47.6070624 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530588, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321446, 47.607049 ], [ -122.3214047, 47.6070624 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530589, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321446, 47.607049 ], [ -122.3214137, 47.6070759 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534664, "project_id": 13, "task_id": 183 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262939, 47.5974367 ], [ -122.3264604, 47.5974398 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534665, "project_id": 13, "task_id": 183 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265144, 47.5974721 ], [ -122.3265037, 47.597581 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534666, "project_id": 13, "task_id": 183 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264658, 47.5975993 ], [ -122.3262945, 47.5975971 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534667, "project_id": 13, "task_id": 183 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262693, 47.5975813 ], [ -122.3262655, 47.5974597 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534668, "project_id": 13, "task_id": 183 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262614, 47.5974434 ], [ -122.3262713, 47.5974272 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534669, "project_id": 13, "task_id": 183 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262939, 47.5974367 ], [ -122.3262713, 47.5974272 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534670, "project_id": 13, "task_id": 183 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262655, 47.5974597 ], [ -122.3262614, 47.5974434 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534671, "project_id": 13, "task_id": 183 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265016, 47.5974211 ], [ -122.3265269, 47.5974505 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534672, "project_id": 13, "task_id": 183 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265144, 47.5974721 ], [ -122.3265269, 47.5974505 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534673, "project_id": 13, "task_id": 183 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264604, 47.5974398 ], [ -122.3265016, 47.5974211 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534674, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223725, 47.5974085 ], [ -122.3223478, 47.5974078 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534675, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322307, 47.5974482 ], [ -122.3223072, 47.5974366 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534676, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223468, 47.5976157 ], [ -122.322347, 47.5975944 ], [ -122.322304, 47.5975938 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534677, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223037, 47.59758 ], [ -122.322304, 47.5975938 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534678, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322367, 47.597616 ], [ -122.3223468, 47.5976157 ] ] } }, +{ "type": "Feature", "properties": { "id": 1550530, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223462, 47.6046723 ], [ -122.3222518, 47.6045811 ] ] } }, +{ "type": "Feature", "properties": { "id": 1556693, "project_id": 13, "task_id": 111 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3334904, 47.5983485 ], [ -122.3334006, 47.5983861 ], [ -122.3332545, 47.5983882 ] ] } }, +{ "type": "Feature", "properties": { "id": 1556695, "project_id": 13, "task_id": 108 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3334904, 47.5983394 ], [ -122.3334904, 47.5983485 ] ] } }, +{ "type": "Feature", "properties": { "id": 1677344, "project_id": 13, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317125, 47.6008109 ], [ -122.331718, 47.6009227 ] ] } }, +{ "type": "Feature", "properties": { "id": 1677345, "project_id": 13, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331718, 47.6009227 ], [ -122.3315243, 47.6009242 ] ] } }, +{ "type": "Feature", "properties": { "id": 1677347, "project_id": 13, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331542, 47.6008075 ], [ -122.3317125, 47.6008109 ] ] } }, +{ "type": "Feature", "properties": { "id": 1677349, "project_id": 13, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331542, 47.6008075 ], [ -122.3314376, 47.600807 ] ] } }, +{ "type": "Feature", "properties": { "id": 1677351, "project_id": 13, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33172, 47.6007851 ], [ -122.3317468, 47.6008032 ] ] } }, +{ "type": "Feature", "properties": { "id": 1677352, "project_id": 13, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317125, 47.6008109 ], [ -122.3317468, 47.6008032 ] ] } }, +{ "type": "Feature", "properties": { "id": 1677353, "project_id": 13, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317125, 47.6008109 ], [ -122.33172, 47.6007851 ] ] } }, +{ "type": "Feature", "properties": { "id": 1677354, "project_id": 13, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317127, 47.6009583 ], [ -122.331674, 47.6009602 ] ] } }, +{ "type": "Feature", "properties": { "id": 1677355, "project_id": 13, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331718, 47.6009227 ], [ -122.331674, 47.6009602 ] ] } }, +{ "type": "Feature", "properties": { "id": 1677356, "project_id": 13, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331718, 47.6009227 ], [ -122.3317127, 47.6009583 ] ] } }, +{ "type": "Feature", "properties": { "id": 1677357, "project_id": 13, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3315109, 47.6009206 ], [ -122.3314627, 47.6009242 ] ] } }, +{ "type": "Feature", "properties": { "id": 1677359, "project_id": 13, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3315243, 47.6009242 ], [ -122.3315109, 47.6009206 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680807, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194939, 47.6008404 ], [ -122.3195174, 47.6009146 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680808, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319482, 47.6009761 ], [ -122.319375, 47.6009927 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680809, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192734, 47.6009329 ], [ -122.3192518, 47.6008714 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680810, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193239, 47.6008295 ], [ -122.3194345, 47.6008125 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680811, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193239, 47.6008295 ], [ -122.3192419, 47.6008427 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680812, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192518, 47.6008714 ], [ -122.3192466, 47.6008559 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680813, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194758, 47.6008096 ], [ -122.3194826, 47.6008226 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680814, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194939, 47.6008404 ], [ -122.3194826, 47.6008226 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680815, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194345, 47.6008125 ], [ -122.3194758, 47.6008096 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680816, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195243, 47.600939 ], [ -122.3195318, 47.600968 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680817, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319482, 47.6009761 ], [ -122.3195318, 47.600968 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680818, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195174, 47.6009146 ], [ -122.3195243, 47.600939 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680819, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192943, 47.6010055 ], [ -122.3192781, 47.6009508 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680820, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192734, 47.6009329 ], [ -122.3192781, 47.6009508 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680821, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319375, 47.6009927 ], [ -122.3192943, 47.6010055 ] ] } }, +{ "type": "Feature", "properties": { "id": 1689244, "project_id": 13, "task_id": 21 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3393064, 47.6022508 ], [ -122.339017, 47.6022508 ] ] } }, +{ "type": "Feature", "properties": { "id": 1689245, "project_id": 13, "task_id": 21 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3390036, 47.6022418 ], [ -122.3390062, 47.6020448 ] ] } }, +{ "type": "Feature", "properties": { "id": 1689246, "project_id": 13, "task_id": 22 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.339025, 47.6019851 ], [ -122.3393145, 47.6019761 ] ] } }, +{ "type": "Feature", "properties": { "id": 1689247, "project_id": 13, "task_id": 22 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3390062, 47.6020357 ], [ -122.3390116, 47.6019869 ] ] } }, +{ "type": "Feature", "properties": { "id": 1689248, "project_id": 13, "task_id": 22 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.339025, 47.6019851 ], [ -122.3390116, 47.6019869 ] ] } }, +{ "type": "Feature", "properties": { "id": 1689249, "project_id": 13, "task_id": 22 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3390062, 47.6020448 ], [ -122.3390062, 47.6020357 ] ] } }, +{ "type": "Feature", "properties": { "id": 1689250, "project_id": 13, "task_id": 21 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3393279, 47.6019743 ], [ -122.3393199, 47.6022508 ] ] } }, +{ "type": "Feature", "properties": { "id": 1689251, "project_id": 13, "task_id": 21 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3393064, 47.6022508 ], [ -122.3393199, 47.6022508 ] ] } }, +{ "type": "Feature", "properties": { "id": 1689252, "project_id": 13, "task_id": 22 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3393145, 47.6019761 ], [ -122.3393279, 47.6019743 ] ] } }, +{ "type": "Feature", "properties": { "id": 1689256, "project_id": 13, "task_id": 489 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3378842, 47.6019653 ], [ -122.3380316, 47.6020538 ] ] } }, +{ "type": "Feature", "properties": { "id": 1689257, "project_id": 13, "task_id": 489 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3380316, 47.6020629 ], [ -122.3380316, 47.6020538 ] ] } }, +{ "type": "Feature", "properties": { "id": 1689258, "project_id": 13, "task_id": 489 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3378708, 47.6019634 ], [ -122.3378842, 47.6019653 ] ] } }, +{ "type": "Feature", "properties": { "id": 1689261, "project_id": 13, "task_id": 489 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3380236, 47.6022382 ], [ -122.3380236, 47.6022472 ] ] } }, +{ "type": "Feature", "properties": { "id": 1690344, "project_id": 13, "task_id": 432 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3389829, 47.60307 ], [ -122.3389775, 47.602873 ] ] } }, +{ "type": "Feature", "properties": { "id": 1690345, "project_id": 13, "task_id": 432 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.339015, 47.6027808 ], [ -122.3393072, 47.6027808 ] ] } }, +{ "type": "Feature", "properties": { "id": 1690346, "project_id": 13, "task_id": 432 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3389775, 47.602864 ], [ -122.3390016, 47.6027808 ] ] } }, +{ "type": "Feature", "properties": { "id": 1690347, "project_id": 13, "task_id": 432 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.339015, 47.6027808 ], [ -122.3390016, 47.6027808 ] ] } }, +{ "type": "Feature", "properties": { "id": 1690348, "project_id": 13, "task_id": 432 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3389775, 47.602873 ], [ -122.3389775, 47.602864 ] ] } }, +{ "type": "Feature", "properties": { "id": 1690349, "project_id": 13, "task_id": 432 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3393206, 47.6027808 ], [ -122.3389855, 47.603079 ] ] } }, +{ "type": "Feature", "properties": { "id": 1690350, "project_id": 13, "task_id": 432 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3389829, 47.60307 ], [ -122.3389855, 47.603079 ] ] } }, +{ "type": "Feature", "properties": { "id": 1690351, "project_id": 13, "task_id": 432 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3393072, 47.6027808 ], [ -122.3393206, 47.6027808 ] ] } }, +{ "type": "Feature", "properties": { "id": 1693158, "project_id": 13, "task_id": 51 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320915, 47.6064196 ], [ -122.3209094, 47.6065185 ] ] } }, +{ "type": "Feature", "properties": { "id": 1693159, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208922, 47.6063017 ], [ -122.3208836, 47.6063629 ], [ -122.3208901, 47.6063864 ], [ -122.3209089, 47.6064069 ] ] } }, +{ "type": "Feature", "properties": { "id": 1693160, "project_id": 13, "task_id": 51 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320915, 47.6064196 ], [ -122.3209089, 47.6064069 ] ] } }, +{ "type": "Feature", "properties": { "id": 1693162, "project_id": 13, "task_id": 51 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209093, 47.6065418 ], [ -122.3208978, 47.606556 ] ] } }, +{ "type": "Feature", "properties": { "id": 1693164, "project_id": 13, "task_id": 51 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209094, 47.6065185 ], [ -122.3209093, 47.6065418 ] ] } }, +{ "type": "Feature", "properties": { "id": 1693165, "project_id": 13, "task_id": 51 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206314, 47.6065561 ], [ -122.3206333, 47.6063367 ] ] } }, +{ "type": "Feature", "properties": { "id": 1694584, "project_id": 13, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3315799, 47.6010169 ], [ -122.3315808, 47.6011038 ] ] } }, +{ "type": "Feature", "properties": { "id": 1694587, "project_id": 13, "task_id": 116 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3313074, 47.6012213 ], [ -122.3311681, 47.6010623 ] ] } }, +{ "type": "Feature", "properties": { "id": 1698651, "project_id": 13, "task_id": 124 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3296562, 47.605744 ], [ -122.3297152, 47.6058206 ] ] } }, +{ "type": "Feature", "properties": { "id": 1698654, "project_id": 13, "task_id": 124 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329438, 47.605897 ], [ -122.329379, 47.6058337 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700646, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3228846, 47.6033492 ], [ -122.3229447, 47.6034149 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700647, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3229272, 47.6034707 ], [ -122.322811, 47.6035177 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700648, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3227359, 47.6035041 ], [ -122.3226758, 47.6034372 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700649, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226987, 47.6033716 ], [ -122.3227896, 47.6033325 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700650, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226368, 47.6033999 ], [ -122.3226499, 47.6033946 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700651, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226987, 47.6033716 ], [ -122.3226499, 47.6033946 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700652, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226758, 47.6034372 ], [ -122.3226368, 47.6033999 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700654, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3228846, 47.6033492 ], [ -122.3228457, 47.6033089 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700655, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3227896, 47.6033325 ], [ -122.3228457, 47.6033089 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700656, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3229447, 47.6034149 ], [ -122.3229766, 47.6034515 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700657, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3229272, 47.6034707 ], [ -122.3229766, 47.6034515 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700659, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322769, 47.603535 ], [ -122.3227593, 47.6035274 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700660, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3227359, 47.6035041 ], [ -122.3227593, 47.6035274 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700661, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322811, 47.6035177 ], [ -122.322769, 47.603535 ] ] } }, +{ "type": "Feature", "properties": { "id": 1701456, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278335, 47.605329 ], [ -122.3281096, 47.6052133 ] ] } }, +{ "type": "Feature", "properties": { "id": 1701457, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327788, 47.6053488 ], [ -122.3278228, 47.6053326 ] ] } }, +{ "type": "Feature", "properties": { "id": 1701458, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278335, 47.605329 ], [ -122.3278228, 47.6053326 ] ] } }, +{ "type": "Feature", "properties": { "id": 1701462, "project_id": 13, "task_id": 370 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3281096, 47.6052133 ], [ -122.328123, 47.6052079 ] ] } }, +{ "type": "Feature", "properties": { "id": 1702199, "project_id": 13, "task_id": 204 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3359652, 47.5984203 ], [ -122.3357691, 47.5984243 ] ] } }, +{ "type": "Feature", "properties": { "id": 1702205, "project_id": 13, "task_id": 31 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360262, 47.5982722 ], [ -122.3360341, 47.5983593 ], [ -122.3359936, 47.598418 ] ] } }, +{ "type": "Feature", "properties": { "id": 1702206, "project_id": 13, "task_id": 204 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3359652, 47.5984203 ], [ -122.3359936, 47.598418 ] ] } }, +{ "type": "Feature", "properties": { "id": 1702207, "project_id": 13, "task_id": 31 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3359473, 47.5980738 ], [ -122.3359948, 47.5980917 ] ] } }, +{ "type": "Feature", "properties": { "id": 1702210, "project_id": 13, "task_id": 204 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3357691, 47.5984243 ], [ -122.3357567, 47.5984251 ] ] } }, +{ "type": "Feature", "properties": { "id": 1711478, "project_id": 13, "task_id": 3 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288872, 47.5984814 ], [ -122.328878, 47.5981627 ] ] } }, +{ "type": "Feature", "properties": { "id": 1711481, "project_id": 13, "task_id": 372 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3292034, 47.5984163 ], [ -122.32921, 47.5985231 ] ] } }, +{ "type": "Feature", "properties": { "id": 1717378, "project_id": 13, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335782, 47.5991071 ], [ -122.3358078, 47.5991084 ] ] } }, +{ "type": "Feature", "properties": { "id": 1717379, "project_id": 13, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358342, 47.599107 ], [ -122.3358078, 47.5991084 ] ] } }, +{ "type": "Feature", "properties": { "id": 1718630, "project_id": 13, "task_id": 257 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332139, 47.6033874 ], [ -122.332232, 47.6034965 ] ] } }, +{ "type": "Feature", "properties": { "id": 1718631, "project_id": 13, "task_id": 257 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332232, 47.6034965 ], [ -122.332028, 47.6035925 ] ] } }, +{ "type": "Feature", "properties": { "id": 1718632, "project_id": 13, "task_id": 257 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332028, 47.6035925 ], [ -122.331918, 47.6034783 ] ] } }, +{ "type": "Feature", "properties": { "id": 1718633, "project_id": 13, "task_id": 257 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331918, 47.6034783 ], [ -122.332139, 47.6033874 ] ] } }, +{ "type": "Feature", "properties": { "id": 1718634, "project_id": 13, "task_id": 257 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3318795, 47.6034871 ], [ -122.3318906, 47.6034594 ] ] } }, +{ "type": "Feature", "properties": { "id": 1718635, "project_id": 13, "task_id": 257 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331918, 47.6034783 ], [ -122.3318906, 47.6034594 ] ] } }, +{ "type": "Feature", "properties": { "id": 1718636, "project_id": 13, "task_id": 257 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331918, 47.6034783 ], [ -122.3318795, 47.6034871 ] ] } }, +{ "type": "Feature", "properties": { "id": 1718637, "project_id": 13, "task_id": 257 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3321105, 47.603358 ], [ -122.3321531, 47.6033687 ] ] } }, +{ "type": "Feature", "properties": { "id": 1718638, "project_id": 13, "task_id": 257 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332139, 47.6033874 ], [ -122.3321531, 47.6033687 ] ] } }, +{ "type": "Feature", "properties": { "id": 1718639, "project_id": 13, "task_id": 257 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332139, 47.6033874 ], [ -122.3321105, 47.603358 ] ] } }, +{ "type": "Feature", "properties": { "id": 1718640, "project_id": 13, "task_id": 257 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3322579, 47.6034881 ], [ -122.3322499, 47.6035116 ] ] } }, +{ "type": "Feature", "properties": { "id": 1718641, "project_id": 13, "task_id": 257 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332232, 47.6034965 ], [ -122.3322499, 47.6035116 ] ] } }, +{ "type": "Feature", "properties": { "id": 1718642, "project_id": 13, "task_id": 257 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332232, 47.6034965 ], [ -122.3322579, 47.6034881 ] ] } }, +{ "type": "Feature", "properties": { "id": 1718643, "project_id": 13, "task_id": 257 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332022, 47.6036074 ], [ -122.3319845, 47.6036002 ] ] } }, +{ "type": "Feature", "properties": { "id": 1718644, "project_id": 13, "task_id": 257 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332028, 47.6035925 ], [ -122.3319845, 47.6036002 ] ] } }, +{ "type": "Feature", "properties": { "id": 1718645, "project_id": 13, "task_id": 257 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332028, 47.6035925 ], [ -122.332022, 47.6036074 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720091, "project_id": 13, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355783, 47.5999678 ], [ -122.335756, 47.5999628 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720092, "project_id": 13, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3357533, 47.60012 ], [ -122.3355727, 47.60012 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720093, "project_id": 13, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354551, 47.600073 ], [ -122.3354584, 47.6000333 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720094, "project_id": 13, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354699, 47.6001237 ], [ -122.3353848, 47.6001183 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720095, "project_id": 13, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354551, 47.600073 ], [ -122.3353848, 47.6001183 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720096, "project_id": 13, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355727, 47.60012 ], [ -122.3354699, 47.6001237 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720097, "project_id": 13, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354518, 47.5999773 ], [ -122.3355124, 47.5999692 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720098, "project_id": 13, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355783, 47.5999678 ], [ -122.3355124, 47.5999692 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720099, "project_id": 13, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354584, 47.6000333 ], [ -122.3354518, 47.5999773 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720101, "project_id": 13, "task_id": 200 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3357533, 47.60012 ], [ -122.335792, 47.6001218 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720102, "project_id": 13, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335756, 47.5999628 ], [ -122.335788, 47.5999617 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720104, "project_id": 13, "task_id": 29 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3357209, 47.5984248 ], [ -122.3355685, 47.5984333 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720105, "project_id": 13, "task_id": 29 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335506, 47.5983737 ], [ -122.3355017, 47.5982214 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720107, "project_id": 13, "task_id": 30 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354266, 47.5982007 ], [ -122.3354748, 47.598061 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720108, "project_id": 13, "task_id": 30 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355574, 47.5980786 ], [ -122.3354748, 47.598061 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720109, "project_id": 13, "task_id": 29 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355017, 47.5982214 ], [ -122.3354266, 47.5982007 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720114, "project_id": 13, "task_id": 204 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3357209, 47.5984248 ], [ -122.3357349, 47.5984239 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720116, "project_id": 13, "task_id": 29 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355072, 47.5984342 ], [ -122.335449, 47.5983995 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720117, "project_id": 13, "task_id": 29 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335506, 47.5983737 ], [ -122.335449, 47.5983995 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720118, "project_id": 13, "task_id": 29 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355685, 47.5984333 ], [ -122.3355072, 47.5984342 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720120, "project_id": 13, "task_id": 97 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354646, 47.6009136 ], [ -122.3354586, 47.6008583 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720121, "project_id": 13, "task_id": 97 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355578, 47.6007987 ], [ -122.3358022, 47.600803 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720122, "project_id": 13, "task_id": 97 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354758, 47.6008057 ], [ -122.3354892, 47.6007764 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720123, "project_id": 13, "task_id": 97 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355578, 47.6007987 ], [ -122.3354892, 47.6007764 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720124, "project_id": 13, "task_id": 97 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354586, 47.6008583 ], [ -122.3354758, 47.6008057 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720128, "project_id": 13, "task_id": 97 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335593, 47.6012037 ], [ -122.3354967, 47.6009598 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720129, "project_id": 13, "task_id": 97 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354646, 47.6009136 ], [ -122.3354967, 47.6009598 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720132, "project_id": 13, "task_id": 93 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3357671, 47.5993367 ], [ -122.3355876, 47.5993444 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720133, "project_id": 13, "task_id": 93 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354685, 47.5992682 ], [ -122.335465, 47.5991543 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720134, "project_id": 13, "task_id": 93 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355757, 47.5991021 ], [ -122.3357666, 47.5991085 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720136, "project_id": 13, "task_id": 93 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355757, 47.5991021 ], [ -122.3355245, 47.5991032 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720137, "project_id": 13, "task_id": 93 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335465, 47.5991543 ], [ -122.3354591, 47.5991305 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720140, "project_id": 13, "task_id": 93 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3357666, 47.5991085 ], [ -122.335782, 47.5991071 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720142, "project_id": 13, "task_id": 93 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3357671, 47.5993367 ], [ -122.335784, 47.5993359 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720144, "project_id": 13, "task_id": 93 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355288, 47.5993243 ], [ -122.3354658, 47.5992917 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720145, "project_id": 13, "task_id": 93 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354685, 47.5992682 ], [ -122.3354658, 47.5992917 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720146, "project_id": 13, "task_id": 93 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355876, 47.5993444 ], [ -122.3355288, 47.5993243 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720147, "project_id": 13, "task_id": 348 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.337069, 47.6024991 ], [ -122.336851, 47.6025921 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720148, "project_id": 13, "task_id": 348 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336753, 47.6026166 ], [ -122.3366212, 47.602487 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720149, "project_id": 13, "task_id": 348 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33665, 47.602415 ], [ -122.3368743, 47.6023219 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720150, "project_id": 13, "task_id": 348 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3366015, 47.6024482 ], [ -122.3366192, 47.6024088 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720151, "project_id": 13, "task_id": 348 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33665, 47.602415 ], [ -122.3366192, 47.6024088 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720152, "project_id": 13, "task_id": 348 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3366212, 47.602487 ], [ -122.3366015, 47.6024482 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720153, "project_id": 13, "task_id": 348 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336898, 47.6023003 ], [ -122.3370802, 47.6024937 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720154, "project_id": 13, "task_id": 348 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.337069, 47.6024991 ], [ -122.3370802, 47.6024937 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720155, "project_id": 13, "task_id": 348 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3368743, 47.6023219 ], [ -122.336898, 47.6023003 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720156, "project_id": 13, "task_id": 348 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3368122, 47.6026076 ], [ -122.3367613, 47.6026238 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720157, "project_id": 13, "task_id": 348 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336753, 47.6026166 ], [ -122.3367613, 47.6026238 ] ] } }, +{ "type": "Feature", "properties": { "id": 1720158, "project_id": 13, "task_id": 348 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336851, 47.6025921 ], [ -122.3368122, 47.6026076 ] ] } }, +{ "type": "Feature", "properties": { "id": 1733128, "project_id": 13, "task_id": 523 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303799, 47.6011878 ], [ -122.3303799, 47.6012601 ] ] } }, +{ "type": "Feature", "properties": { "id": 1733131, "project_id": 13, "task_id": 523 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330175, 47.6014699 ], [ -122.3301763, 47.6011845 ] ] } }, +{ "type": "Feature", "properties": { "id": 1742499, "project_id": 13, "task_id": 181 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278525, 47.5960382 ], [ -122.3276067, 47.5959989 ] ] } }, +{ "type": "Feature", "properties": { "id": 1742500, "project_id": 13, "task_id": 75 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275327, 47.5959445 ], [ -122.3273097, 47.5957413 ] ] } }, +{ "type": "Feature", "properties": { "id": 1742501, "project_id": 13, "task_id": 181 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275637, 47.5959735 ], [ -122.3275184, 47.5959569 ] ] } }, +{ "type": "Feature", "properties": { "id": 1742502, "project_id": 13, "task_id": 181 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275327, 47.5959445 ], [ -122.3275184, 47.5959569 ] ] } }, +{ "type": "Feature", "properties": { "id": 1742503, "project_id": 13, "task_id": 181 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3276067, 47.5959989 ], [ -122.3275637, 47.5959735 ] ] } }, +{ "type": "Feature", "properties": { "id": 1742504, "project_id": 13, "task_id": 72 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3279892, 47.5958249 ], [ -122.3279189, 47.5960356 ] ] } }, +{ "type": "Feature", "properties": { "id": 1742505, "project_id": 13, "task_id": 68 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278525, 47.5960382 ], [ -122.3278645, 47.5960377 ], [ -122.3279189, 47.5960356 ] ] } }, +{ "type": "Feature", "properties": { "id": 1747871, "project_id": 13, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3237589, 47.608011 ], [ -122.3236847, 47.6079247 ] ] } }, +{ "type": "Feature", "properties": { "id": 1747872, "project_id": 13, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3237185, 47.6078849 ], [ -122.3238905, 47.6078151 ] ] } }, +{ "type": "Feature", "properties": { "id": 1747873, "project_id": 13, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236727, 47.6079026 ], [ -122.3236938, 47.6078928 ] ] } }, +{ "type": "Feature", "properties": { "id": 1747874, "project_id": 13, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3237185, 47.6078849 ], [ -122.3236938, 47.6078928 ] ] } }, +{ "type": "Feature", "properties": { "id": 1747875, "project_id": 13, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236847, 47.6079247 ], [ -122.3236727, 47.6079026 ] ] } }, +{ "type": "Feature", "properties": { "id": 1747877, "project_id": 13, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3237589, 47.608011 ], [ -122.3237916, 47.6080268 ] ] } }, +{ "type": "Feature", "properties": { "id": 1750662, "project_id": 13, "task_id": 478 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3312393, 47.6074642 ], [ -122.331391, 47.6076219 ] ] } }, +{ "type": "Feature", "properties": { "id": 1752562, "project_id": 13, "task_id": 96 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3390189, 47.6046552 ], [ -122.3388089, 47.6047501 ] ] } }, +{ "type": "Feature", "properties": { "id": 1752563, "project_id": 13, "task_id": 96 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.338715, 47.6047321 ], [ -122.338621, 47.6046255 ] ] } }, +{ "type": "Feature", "properties": { "id": 1752564, "project_id": 13, "task_id": 96 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3386453, 47.6045618 ], [ -122.3388575, 47.6044788 ] ] } }, +{ "type": "Feature", "properties": { "id": 1752565, "project_id": 13, "task_id": 96 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3386138, 47.6046183 ], [ -122.3386111, 47.6045803 ] ] } }, +{ "type": "Feature", "properties": { "id": 1752566, "project_id": 13, "task_id": 96 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3386453, 47.6045618 ], [ -122.3386111, 47.6045803 ] ] } }, +{ "type": "Feature", "properties": { "id": 1752567, "project_id": 13, "task_id": 96 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.338621, 47.6046255 ], [ -122.3386138, 47.6046183 ] ] } }, +{ "type": "Feature", "properties": { "id": 1752568, "project_id": 13, "task_id": 96 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3388818, 47.6044665 ], [ -122.3390507, 47.604649 ] ] } }, +{ "type": "Feature", "properties": { "id": 1752569, "project_id": 13, "task_id": 96 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3390189, 47.6046552 ], [ -122.3390507, 47.604649 ] ] } }, +{ "type": "Feature", "properties": { "id": 1752570, "project_id": 13, "task_id": 96 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3388575, 47.6044788 ], [ -122.3388818, 47.6044665 ] ] } }, +{ "type": "Feature", "properties": { "id": 1752571, "project_id": 13, "task_id": 96 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3387799, 47.6047629 ], [ -122.3387237, 47.6047412 ] ] } }, +{ "type": "Feature", "properties": { "id": 1752572, "project_id": 13, "task_id": 96 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.338715, 47.6047321 ], [ -122.3387237, 47.6047412 ] ] } }, +{ "type": "Feature", "properties": { "id": 1752573, "project_id": 13, "task_id": 96 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3388089, 47.6047501 ], [ -122.3387799, 47.6047629 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779581, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218195, 47.6039294 ], [ -122.3217102, 47.6039693 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779582, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3216599, 47.6039526 ], [ -122.3216157, 47.6038848 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779583, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3217699, 47.6038134 ], [ -122.3218367, 47.6038816 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779584, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3215905, 47.6038614 ], [ -122.3217482, 47.6037958 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779585, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3217699, 47.6038134 ], [ -122.3217482, 47.6037958 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779586, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3216157, 47.6038848 ], [ -122.3215905, 47.6038614 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779588, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218195, 47.6039294 ], [ -122.3218631, 47.6039167 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779589, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218367, 47.6038816 ], [ -122.321855, 47.6039077 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779590, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3216659, 47.6039882 ], [ -122.3216598, 47.6039843 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779591, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3216599, 47.6039526 ], [ -122.3216598, 47.6039843 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779592, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3217102, 47.6039693 ], [ -122.3216659, 47.6039882 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786027, "project_id": 13, "task_id": 69 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3287098, 47.5964334 ], [ -122.32874, 47.5962137 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786028, "project_id": 13, "task_id": 69 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288624, 47.5961886 ], [ -122.3292085, 47.5961923 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786029, "project_id": 13, "task_id": 4 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288725, 47.5974552 ], [ -122.3288645, 47.596573 ], [ -122.3288233, 47.5965253 ], [ -122.328693, 47.5964585 ], [ -122.328107, 47.5961489 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786030, "project_id": 13, "task_id": 69 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3292085, 47.5961923 ], [ -122.3292393, 47.5961824 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786031, "project_id": 13, "task_id": 69 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3287098, 47.5964334 ], [ -122.328693, 47.5964585 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786032, "project_id": 13, "task_id": 69 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.32874, 47.5962137 ], [ -122.3287897, 47.5961804 ], [ -122.3288624, 47.5961886 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786033, "project_id": 13, "task_id": 69 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328163, 47.5958857 ], [ -122.3287411, 47.5961794 ], [ -122.3287897, 47.5961804 ], [ -122.3288619, 47.5961347 ], [ -122.3288767, 47.5952065 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786034, "project_id": 13, "task_id": 78 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3263017, 47.5959503 ], [ -122.3262813, 47.595952 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786035, "project_id": 13, "task_id": 78 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262639, 47.5959279 ], [ -122.3262813, 47.595952 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786036, "project_id": 13, "task_id": 75 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3272664, 47.5957414 ], [ -122.3273097, 47.5957413 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786037, "project_id": 13, "task_id": 181 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327581, 47.595601 ], [ -122.327678, 47.5956457 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786038, "project_id": 13, "task_id": 181 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327678, 47.5956457 ], [ -122.3277049, 47.5956581 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786039, "project_id": 13, "task_id": 181 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277049, 47.5956581 ], [ -122.3279137, 47.5957539 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786040, "project_id": 13, "task_id": 72 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3279137, 47.5957539 ], [ -122.3280111, 47.5957986 ], [ -122.3279892, 47.5958249 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786041, "project_id": 13, "task_id": 72 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3280111, 47.5957986 ], [ -122.328163, 47.5958857 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786042, "project_id": 13, "task_id": 461 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288694, 47.5994542 ], [ -122.3288597, 47.5993318 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786043, "project_id": 13, "task_id": 465 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291864, 47.5991146 ], [ -122.3291741, 47.5991247 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786044, "project_id": 13, "task_id": 465 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291741, 47.5991247 ], [ -122.3291524, 47.5993051 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786045, "project_id": 13, "task_id": 461 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288936, 47.5993482 ], [ -122.3291524, 47.5993051 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786046, "project_id": 13, "task_id": 461 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288597, 47.5993318 ], [ -122.3288936, 47.5993482 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786047, "project_id": 13, "task_id": 465 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291524, 47.5993051 ], [ -122.3291785, 47.599312 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786048, "project_id": 13, "task_id": 380 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3296419, 47.5993046 ], [ -122.3291918, 47.5993013 ], [ -122.3291785, 47.599312 ], [ -122.3291624, 47.5993498 ], [ -122.3291565, 47.5995952 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786068, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195004, 47.6027567 ], [ -122.31951, 47.6029176 ], [ -122.319526, 47.6031162 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786069, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195588, 47.6027562 ], [ -122.3195004, 47.6027567 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786070, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195004, 47.6027567 ], [ -122.319426, 47.6027537 ], [ -122.3193283, 47.6027463 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786091, "project_id": 13, "task_id": 163 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320882, 47.607068 ], [ -122.320653, 47.6071259 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786093, "project_id": 13, "task_id": 163 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209239, 47.607089 ], [ -122.3209199, 47.607073 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786094, "project_id": 13, "task_id": 163 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209477, 47.6070615 ], [ -122.3209199, 47.607073 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786095, "project_id": 13, "task_id": 163 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209002, 47.6070431 ], [ -122.3209199, 47.607073 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786096, "project_id": 13, "task_id": 163 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209199, 47.607073 ], [ -122.320882, 47.607068 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786102, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320438, 47.6062917 ], [ -122.3197449, 47.6062927 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786111, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319333, 47.6052722 ], [ -122.3193402, 47.6057132 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786112, "project_id": 13, "task_id": 41 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197447, 47.6052765 ], [ -122.3194979, 47.6052714 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786113, "project_id": 13, "task_id": 41 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195049, 47.6057112 ], [ -122.3194994, 47.6054724 ], [ -122.3194979, 47.6052714 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786114, "project_id": 13, "task_id": 269 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197447, 47.6052765 ], [ -122.320427, 47.6052777 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786115, "project_id": 13, "task_id": 269 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320427, 47.6052777 ], [ -122.3206162, 47.6052754 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786116, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209159, 47.6048634 ], [ -122.3208949, 47.6048453 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786117, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209091, 47.6048715 ], [ -122.3208949, 47.6048453 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786118, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320438, 47.6062917 ], [ -122.3205982, 47.6062892 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786119, "project_id": 13, "task_id": 51 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206314, 47.6065561 ], [ -122.3206308, 47.6066361 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786120, "project_id": 13, "task_id": 163 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206308, 47.6066361 ], [ -122.3206282, 47.6070212 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786121, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3221564, 47.6075823 ], [ -122.3225844, 47.6073932 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786122, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265243, 47.6008043 ], [ -122.3265237, 47.6008244 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786123, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265155, 47.6009515 ], [ -122.32652, 47.6009305 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786124, "project_id": 13, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239767, 47.6082094 ], [ -122.3243282, 47.608597 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786125, "project_id": 13, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324529, 47.6085071 ], [ -122.3244904, 47.6084807 ], [ -122.3243309, 47.6083005 ], [ -122.3241437, 47.6081084 ], [ -122.3240023, 47.607948 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786126, "project_id": 13, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3237916, 47.6080268 ], [ -122.3239767, 47.6082094 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786127, "project_id": 13, "task_id": 291 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236938, 47.6078928 ], [ -122.323577, 47.60776 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786128, "project_id": 13, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238264, 47.6080186 ], [ -122.3237916, 47.6080268 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786129, "project_id": 13, "task_id": 292 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323577, 47.60776 ], [ -122.3232546, 47.6074041 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786130, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238905, 47.6078151 ], [ -122.3233567, 47.6072287 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786131, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225844, 47.6073932 ], [ -122.3230355, 47.607187 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786132, "project_id": 13, "task_id": 292 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3231375, 47.6073152 ], [ -122.323105, 47.607295 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786133, "project_id": 13, "task_id": 292 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3231375, 47.6073152 ], [ -122.323172, 47.6073045 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786134, "project_id": 13, "task_id": 292 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3231375, 47.6073152 ], [ -122.3231801, 47.6073279 ], [ -122.3232546, 47.6074041 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786135, "project_id": 13, "task_id": 292 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3230355, 47.607187 ], [ -122.323038, 47.6072137 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786136, "project_id": 13, "task_id": 292 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3230355, 47.607187 ], [ -122.323046, 47.6071691 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786137, "project_id": 13, "task_id": 292 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3230355, 47.607187 ], [ -122.3229395, 47.6070704 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786138, "project_id": 13, "task_id": 292 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323105, 47.607295 ], [ -122.323038, 47.6072137 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786139, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323172, 47.6073045 ], [ -122.323346, 47.6072359 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786140, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323046, 47.6071691 ], [ -122.3232028, 47.6070985 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786141, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3232541, 47.6071069 ], [ -122.3233465, 47.6072064 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786142, "project_id": 13, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240023, 47.607948 ], [ -122.3238264, 47.6080186 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786143, "project_id": 13, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240111, 47.6079369 ], [ -122.3240065, 47.6079189 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786144, "project_id": 13, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240065, 47.6079189 ], [ -122.3239305, 47.6078213 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786145, "project_id": 13, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239086, 47.6078052 ], [ -122.3238905, 47.6078151 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786146, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3232319, 47.6070979 ], [ -122.3230745, 47.606919 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786147, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323346, 47.6072359 ], [ -122.3233567, 47.6072287 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786148, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3233733, 47.6072235 ], [ -122.3233567, 47.6072287 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786149, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3233465, 47.6072064 ], [ -122.3233733, 47.6072235 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786150, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3232319, 47.6070979 ], [ -122.3232541, 47.6071069 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786151, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3232028, 47.6070985 ], [ -122.3232319, 47.6070979 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786152, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3232319, 47.6070979 ], [ -122.32415, 47.6067105 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786153, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3229395, 47.6070704 ], [ -122.3225662, 47.6066617 ], [ -122.3225195, 47.6066356 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786154, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3230745, 47.606919 ], [ -122.3227516, 47.6065388 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786155, "project_id": 13, "task_id": 162 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3213028, 47.606674 ], [ -122.3214369, 47.606615 ], [ -122.3214532, 47.6065795 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786156, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214337, 47.6068263 ], [ -122.3213801, 47.6067678 ], [ -122.3213028, 47.606674 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786157, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225195, 47.6066356 ], [ -122.322474, 47.6066287 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786158, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225282, 47.6066218 ], [ -122.3225195, 47.6066356 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786159, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3227562, 47.6065115 ], [ -122.3227516, 47.6065388 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786160, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3227516, 47.6065388 ], [ -122.322728, 47.6065355 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786161, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249685, 47.6075403 ], [ -122.3249231, 47.6075582 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786162, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249231, 47.6075582 ], [ -122.3248962, 47.6075322 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786163, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249388, 47.6075707 ], [ -122.3249231, 47.6075582 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786167, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218037, 47.6058731 ], [ -122.3217185, 47.6057896 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786168, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219523, 47.6056619 ], [ -122.3221384, 47.6055839 ], [ -122.3226944, 47.605345 ], [ -122.3228342, 47.6052931 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786174, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3259077, 47.6069661 ], [ -122.3258045, 47.6068479 ], [ -122.3256689, 47.6066888 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786175, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3243377, 47.6066339 ], [ -122.3252312, 47.6062623 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786200, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3256689, 47.6066888 ], [ -122.3253958, 47.6063898 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786201, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252449, 47.6062335 ], [ -122.3250138, 47.6059756 ], [ -122.3247469, 47.6056844 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786243, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320892, 47.6018026 ], [ -122.3208983, 47.6022059 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786267, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236922, 47.6058913 ], [ -122.3237097, 47.6059183 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786268, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236686, 47.6058924 ], [ -122.3236461, 47.6059106 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786273, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194777, 47.6017869 ], [ -122.3194692, 47.6019906 ], [ -122.3194458, 47.602079 ], [ -122.3194163, 47.6021188 ], [ -122.3193594, 47.6021729 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786275, "project_id": 13, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3205895, 47.6026468 ], [ -122.320407, 47.6026382 ], [ -122.3197517, 47.6026444 ], [ -122.3195586, 47.6026425 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786276, "project_id": 13, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3200397, 47.6029378 ], [ -122.3198014, 47.6029396 ], [ -122.3197873, 47.6029486 ], [ -122.3197847, 47.6029699 ], [ -122.3197824, 47.6030882 ], [ -122.3197717, 47.6030913 ], [ -122.3197453, 47.6030913 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786277, "project_id": 13, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3200405, 47.6031115 ], [ -122.3195946, 47.6031126 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786278, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236686, 47.6058924 ], [ -122.3236922, 47.6058913 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786279, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236922, 47.6058913 ], [ -122.3239818, 47.6057766 ], [ -122.32454, 47.6055552 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786280, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3228703, 47.6053088 ], [ -122.3228342, 47.6052931 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786281, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3228887, 47.6052643 ], [ -122.3228378, 47.6052795 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786311, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192781, 47.6009508 ], [ -122.3191208, 47.6009716 ], [ -122.3191061, 47.6009826 ], [ -122.3190048, 47.6009878 ], [ -122.3189783, 47.6009779 ], [ -122.3188233, 47.6009838 ], [ -122.3187478, 47.6009838 ], [ -122.3187016, 47.60098 ], [ -122.318625, 47.6009673 ], [ -122.318582, 47.6009583 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786312, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192518, 47.6008714 ], [ -122.3191783, 47.6008824 ], [ -122.3191038, 47.6008917 ], [ -122.3190544, 47.6008967 ], [ -122.3189979, 47.6008996 ], [ -122.3187821, 47.6009052 ], [ -122.3187297, 47.6009018 ], [ -122.3186787, 47.6008941 ], [ -122.318641, 47.6008864 ], [ -122.318573, 47.6008641 ], [ -122.3185105, 47.60084 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786313, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180691, 47.6015674 ], [ -122.3181307, 47.6015677 ], [ -122.3181305, 47.6015535 ], [ -122.3184174, 47.6015551 ], [ -122.31844, 47.6015611 ], [ -122.318921, 47.6015612 ], [ -122.3194359, 47.6015634 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786323, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3245623, 47.6055161 ], [ -122.3243341, 47.6052764 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786324, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3247811, 47.6054292 ], [ -122.3244941, 47.6051209 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786335, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223293, 47.6017849 ], [ -122.322316, 47.6017533 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786336, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223293, 47.6017849 ], [ -122.3223705, 47.6017859 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786337, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223705, 47.6017859 ], [ -122.3225681, 47.6017856 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786338, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226405, 47.6017886 ], [ -122.3229694, 47.6017912 ], [ -122.3232573, 47.6017916 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786339, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225927, 47.601787 ], [ -122.3226405, 47.6017886 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786340, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226405, 47.6017886 ], [ -122.3226398, 47.6017686 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786341, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226398, 47.6017686 ], [ -122.3226385, 47.6016035 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786342, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322316, 47.6016028 ], [ -122.3223176, 47.6015779 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786343, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223176, 47.6015779 ], [ -122.3223898, 47.6015819 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786344, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223898, 47.6015819 ], [ -122.3225739, 47.601585 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786345, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226369, 47.6015852 ], [ -122.3231219, 47.6015859 ], [ -122.3232581, 47.6016002 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786346, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225739, 47.601585 ], [ -122.3226369, 47.6015852 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786347, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226369, 47.6015852 ], [ -122.3226385, 47.6016035 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786348, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225681, 47.6017856 ], [ -122.3225927, 47.601787 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786349, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225927, 47.601787 ], [ -122.3226061, 47.6019484 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786350, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223176, 47.6015779 ], [ -122.3223173, 47.6015417 ], [ -122.3223034, 47.6015272 ], [ -122.3222564, 47.601509 ], [ -122.3221909, 47.6014866 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786351, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3221909, 47.6014866 ], [ -122.3221059, 47.6014715 ], [ -122.3220167, 47.6014602 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786352, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3221909, 47.6014866 ], [ -122.3221575, 47.6014498 ], [ -122.3221347, 47.601419 ], [ -122.3221179, 47.6013788 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786353, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3221179, 47.6013788 ], [ -122.3221099, 47.6013281 ], [ -122.3220918, 47.601296 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786354, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3221179, 47.6013788 ], [ -122.3220764, 47.6014118 ], [ -122.3220154, 47.6014494 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786355, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3258692, 47.6049876 ], [ -122.3258866, 47.6049807 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786356, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3258609, 47.605001 ], [ -122.3258692, 47.6049876 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786357, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3257274, 47.6050511 ], [ -122.3257445, 47.6050492 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786358, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3257159, 47.6050568 ], [ -122.3257274, 47.6050511 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786379, "project_id": 13, "task_id": 361 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3232581, 47.6016002 ], [ -122.3238414, 47.6016378 ], [ -122.3240119, 47.6016402 ], [ -122.3248717, 47.6016431 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786380, "project_id": 13, "task_id": 361 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236832, 47.6017867 ], [ -122.3239937, 47.6017868 ], [ -122.3248696, 47.6017844 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786386, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192943, 47.6010055 ], [ -122.3193142, 47.6010711 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786387, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195395, 47.6009964 ], [ -122.3195318, 47.600968 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786390, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192419, 47.6008427 ], [ -122.3192034, 47.6007298 ], [ -122.3191638, 47.6006065 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786391, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195318, 47.600968 ], [ -122.3196778, 47.6009482 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786392, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194758, 47.6008096 ], [ -122.3196235, 47.6007865 ], [ -122.3196978, 47.6007772 ], [ -122.3197767, 47.600772 ], [ -122.3198565, 47.6007707 ], [ -122.3199945, 47.600772 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786393, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193837, 47.6005285 ], [ -122.3194758, 47.6008096 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786394, "project_id": 13, "task_id": 361 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3248696, 47.6017844 ], [ -122.326032, 47.6017882 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786395, "project_id": 13, "task_id": 361 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3248717, 47.6016431 ], [ -122.3260345, 47.6016413 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786396, "project_id": 13, "task_id": 361 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3255878, 47.6009413 ], [ -122.3251519, 47.6009389 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786397, "project_id": 13, "task_id": 6 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3191638, 47.6006065 ], [ -122.3190495, 47.600256 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786398, "project_id": 13, "task_id": 5 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192596, 47.6001863 ], [ -122.319279, 47.6002147 ], [ -122.3192918, 47.6002463 ], [ -122.3193837, 47.6005285 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786399, "project_id": 13, "task_id": 5 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197797, 47.6001479 ], [ -122.3195701, 47.6001473 ], [ -122.3195191, 47.6001493 ], [ -122.3194621, 47.6001563 ], [ -122.3192596, 47.6001863 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786400, "project_id": 13, "task_id": 6 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192029, 47.600146 ], [ -122.3192342, 47.6001642 ], [ -122.3192596, 47.6001863 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786406, "project_id": 13, "task_id": 6 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3190495, 47.600256 ], [ -122.3184541, 47.6001199 ], [ -122.3183625, 47.6001041 ], [ -122.3181915, 47.600104 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786407, "project_id": 13, "task_id": 6 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3190935, 47.6002453 ], [ -122.3191723, 47.6001709 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786408, "project_id": 13, "task_id": 6 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3191723, 47.6001709 ], [ -122.3192029, 47.600146 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786409, "project_id": 13, "task_id": 6 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3190495, 47.600256 ], [ -122.3190935, 47.6002453 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786424, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264516, 47.6009629 ], [ -122.3262843, 47.6009686 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786425, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264724, 47.600805 ], [ -122.3262691, 47.6008016 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786426, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262352, 47.6009223 ], [ -122.3262284, 47.6008296 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786427, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3255878, 47.6009413 ], [ -122.3260389, 47.6009531 ], [ -122.3262394, 47.6009455 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786428, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262606, 47.6009694 ], [ -122.3262712, 47.6011521 ], [ -122.3262603, 47.6012987 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786429, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262394, 47.6009455 ], [ -122.3262606, 47.6009694 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786430, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262843, 47.6009686 ], [ -122.3262606, 47.6009694 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786431, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262394, 47.6009455 ], [ -122.3262352, 47.6009223 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786432, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265243, 47.6008043 ], [ -122.3264928, 47.6008046 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786433, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264928, 47.6008046 ], [ -122.3264724, 47.600805 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786434, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264928, 47.6008046 ], [ -122.3264871, 47.6007798 ], [ -122.3264878, 47.6004385 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786435, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264809, 47.6009628 ], [ -122.3264579, 47.6010036 ], [ -122.3264612, 47.6011153 ], [ -122.3264739, 47.6011301 ], [ -122.326476, 47.6013037 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786436, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265155, 47.6009515 ], [ -122.3264809, 47.6009628 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786437, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264809, 47.6009628 ], [ -122.3264516, 47.6009629 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786438, "project_id": 13, "task_id": 123 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262263, 47.6008091 ], [ -122.3255831, 47.6008003 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786439, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262691, 47.6008016 ], [ -122.3262453, 47.6008005 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786440, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262263, 47.6008091 ], [ -122.3262284, 47.6008296 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786441, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262453, 47.6008005 ], [ -122.3262263, 47.6008091 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786442, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262453, 47.6008005 ], [ -122.3262622, 47.6007668 ], [ -122.3262713, 47.6004451 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786445, "project_id": 13, "task_id": 138 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3187193, 47.6026956 ], [ -122.3184591, 47.6024468 ], [ -122.3184118, 47.6024033 ], [ -122.3183852, 47.6023855 ], [ -122.3183428, 47.602364 ], [ -122.3183107, 47.6023453 ], [ -122.3182856, 47.6023254 ], [ -122.3182649, 47.6023012 ], [ -122.31825, 47.6022798 ], [ -122.3182407, 47.6022566 ], [ -122.318232, 47.6022321 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786450, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3243341, 47.6052764 ], [ -122.3240874, 47.604983 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786451, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240874, 47.604983 ], [ -122.3240898, 47.6049669 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786452, "project_id": 13, "task_id": 359 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324288, 47.6048662 ], [ -122.3248222, 47.6046413 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786453, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324288, 47.6048662 ], [ -122.3242779, 47.6048564 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786454, "project_id": 13, "task_id": 396 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239748, 47.6048006 ], [ -122.3239307, 47.6048046 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786455, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3242781, 47.60489 ], [ -122.3244941, 47.6051209 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786456, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240898, 47.6049669 ], [ -122.3242549, 47.6048944 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786457, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3242549, 47.6048944 ], [ -122.3242781, 47.60489 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786458, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3242779, 47.6048564 ], [ -122.3241946, 47.6047691 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786459, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3241946, 47.6047691 ], [ -122.3241756, 47.6047569 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786460, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3241756, 47.6047569 ], [ -122.3241267, 47.6047563 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786461, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3241267, 47.6047563 ], [ -122.3241113, 47.6047691 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786462, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3241113, 47.6047691 ], [ -122.3239748, 47.6048006 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786463, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3242781, 47.60489 ], [ -122.324288, 47.6048662 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786464, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240874, 47.604983 ], [ -122.324029, 47.6049771 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786465, "project_id": 13, "task_id": 396 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239307, 47.6048046 ], [ -122.323922, 47.6048299 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786466, "project_id": 13, "task_id": 396 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239658, 47.6048428 ], [ -122.323922, 47.6048299 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786467, "project_id": 13, "task_id": 149 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3241267, 47.6047563 ], [ -122.3229766, 47.6034515 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786468, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324029, 47.6049771 ], [ -122.3240296, 47.6049575 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786499, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262882, 47.6017746 ], [ -122.3262658, 47.6016492 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786500, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264459, 47.6017906 ], [ -122.326339, 47.6017871 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786501, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3263032, 47.6016247 ], [ -122.3264181, 47.6016168 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786502, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264913, 47.6016545 ], [ -122.3264898, 47.6017776 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786503, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260345, 47.6016413 ], [ -122.326265, 47.6016377 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786504, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326032, 47.6017882 ], [ -122.3262891, 47.601788 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786505, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262891, 47.601788 ], [ -122.3262882, 47.6017746 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786506, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326265, 47.6016377 ], [ -122.3262658, 47.6016492 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786507, "project_id": 13, "task_id": 443 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3263196, 47.6017887 ], [ -122.326333, 47.601811 ], [ -122.3263352, 47.6019307 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786508, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262891, 47.601788 ], [ -122.3263196, 47.6017887 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786509, "project_id": 13, "task_id": 443 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264381, 47.6019156 ], [ -122.3264425, 47.6018135 ], [ -122.326464, 47.601798 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786510, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264889, 47.6017889 ], [ -122.3267194, 47.6017963 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786511, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326464, 47.601798 ], [ -122.3264889, 47.6017889 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786512, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264898, 47.6017776 ], [ -122.3264889, 47.6017889 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786513, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326715, 47.601634 ], [ -122.326492, 47.601633 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786514, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326492, 47.601633 ], [ -122.3264913, 47.6016545 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786515, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326492, 47.601633 ], [ -122.3264781, 47.6016131 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786516, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264781, 47.6016131 ], [ -122.326476, 47.6013037 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786517, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264781, 47.6016131 ], [ -122.3264181, 47.6016168 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786518, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262603, 47.6012987 ], [ -122.3262593, 47.6014801 ], [ -122.3262645, 47.6016224 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786519, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262645, 47.6016224 ], [ -122.326265, 47.6016377 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786520, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3263032, 47.6016247 ], [ -122.3262645, 47.6016224 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786521, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326464, 47.601798 ], [ -122.3264459, 47.6017906 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786522, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326339, 47.6017871 ], [ -122.3263196, 47.6017887 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786529, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3230281, 47.6051941 ], [ -122.3225334, 47.6046472 ], [ -122.3225045, 47.6046151 ], [ -122.3224137, 47.6045147 ], [ -122.3223918, 47.6044908 ], [ -122.3220464, 47.6041164 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786534, "project_id": 13, "task_id": 457 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3267194, 47.6017963 ], [ -122.3275427, 47.6017942 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786535, "project_id": 13, "task_id": 457 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326715, 47.601634 ], [ -122.327553, 47.6016436 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786536, "project_id": 13, "task_id": 457 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275455, 47.6015079 ], [ -122.327553, 47.6016436 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786537, "project_id": 13, "task_id": 457 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327553, 47.6016436 ], [ -122.3276106, 47.6016444 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786538, "project_id": 13, "task_id": 457 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327553, 47.6016436 ], [ -122.3275427, 47.6017942 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786539, "project_id": 13, "task_id": 459 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275427, 47.6017942 ], [ -122.3277942, 47.6017938 ], [ -122.3281455, 47.6017933 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786540, "project_id": 13, "task_id": 457 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275427, 47.6017942 ], [ -122.3275074, 47.6018844 ], [ -122.3275109, 47.6019721 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786541, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3222518, 47.6045811 ], [ -122.3221983, 47.6045695 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786542, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223462, 47.6046723 ], [ -122.3223258, 47.604693 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786543, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223258, 47.604693 ], [ -122.3223348, 47.6047037 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786607, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3216659, 47.6039882 ], [ -122.3221983, 47.6045695 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786608, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3222518, 47.6045811 ], [ -122.3223724, 47.6045267 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786609, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223724, 47.6045267 ], [ -122.3223918, 47.6044908 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786610, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223462, 47.6046723 ], [ -122.3224506, 47.6046219 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786611, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3224506, 47.6046219 ], [ -122.3225045, 47.6046151 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786625, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3261993, 47.5999745 ], [ -122.326204, 47.6000982 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786626, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262539, 47.5999316 ], [ -122.3262597, 47.5996038 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786627, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264683, 47.5999323 ], [ -122.3262788, 47.5999314 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786628, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265323, 47.5999736 ], [ -122.3265334, 47.6001025 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786629, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264819, 47.6001098 ], [ -122.3262797, 47.6001152 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786630, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264878, 47.6004385 ], [ -122.3264893, 47.6001207 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786631, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262497, 47.6001176 ], [ -122.3262745, 47.600229 ], [ -122.3262713, 47.6004451 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786634, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3255831, 47.6008003 ], [ -122.3253001, 47.6008019 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786653, "project_id": 13, "task_id": 7 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197755, 47.5990786 ], [ -122.3203336, 47.5990794 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786654, "project_id": 13, "task_id": 7 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197806, 47.5992984 ], [ -122.3203348, 47.5993 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786655, "project_id": 13, "task_id": 7 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197806, 47.5992984 ], [ -122.319741, 47.5993128 ], [ -122.3197348, 47.5996694 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786656, "project_id": 13, "task_id": 7 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195453, 47.5992981 ], [ -122.3195465, 47.5996674 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786657, "project_id": 13, "task_id": 7 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319772, 47.5992767 ], [ -122.3197806, 47.5992984 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786670, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252186, 47.5999574 ], [ -122.3252194, 47.5999691 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786671, "project_id": 13, "task_id": 67 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249357, 47.6001153 ], [ -122.3246932, 47.6001135 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786672, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252186, 47.5999574 ], [ -122.3251852, 47.5999578 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786673, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251852, 47.5999578 ], [ -122.3251533, 47.5999594 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786674, "project_id": 13, "task_id": 14 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251852, 47.5999578 ], [ -122.325184, 47.5998735 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786675, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3253001, 47.6008019 ], [ -122.3251366, 47.6007999 ], [ -122.3250994, 47.6008101 ], [ -122.3250684, 47.6008322 ], [ -122.3250587, 47.600859 ], [ -122.3250596, 47.6008835 ], [ -122.3250764, 47.6009109 ], [ -122.3251089, 47.6009285 ], [ -122.3251519, 47.6009389 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786681, "project_id": 13, "task_id": 67 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3246932, 47.6001135 ], [ -122.324056, 47.6001179 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786687, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193294, 47.6042809 ], [ -122.3193398, 47.6039553 ], [ -122.3193379, 47.6036005 ], [ -122.3193123, 47.6035856 ], [ -122.3188053, 47.6035793 ], [ -122.3182306, 47.6035824 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786703, "project_id": 13, "task_id": 195 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3203348, 47.5993 ], [ -122.3214957, 47.599303 ], [ -122.322204, 47.5992954 ], [ -122.3223465, 47.5992941 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786704, "project_id": 13, "task_id": 186 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223385, 47.599067 ], [ -122.3221879, 47.5990646 ], [ -122.3215028, 47.5990729 ], [ -122.3208303, 47.5990785 ], [ -122.3203336, 47.5990794 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786705, "project_id": 13, "task_id": 186 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225766, 47.5990718 ], [ -122.3225686, 47.5990962 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786706, "project_id": 13, "task_id": 195 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225726, 47.5992928 ], [ -122.3223465, 47.5992941 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786707, "project_id": 13, "task_id": 15 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324056, 47.6001179 ], [ -122.3235618, 47.6001155 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786709, "project_id": 13, "task_id": 15 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323893, 47.5999571 ], [ -122.3238877, 47.5999289 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786711, "project_id": 13, "task_id": 15 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236572, 47.5999591 ], [ -122.3236448, 47.5999555 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786712, "project_id": 13, "task_id": 15 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236448, 47.5999555 ], [ -122.3236488, 47.599931 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786713, "project_id": 13, "task_id": 14 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325184, 47.5998735 ], [ -122.3251873, 47.5997588 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786714, "project_id": 13, "task_id": 83 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251873, 47.5997588 ], [ -122.3251816, 47.5993376 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786729, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3268017, 47.6045848 ], [ -122.3266097, 47.6043544 ], [ -122.3263867, 47.6041064 ], [ -122.3263237, 47.6039915 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786730, "project_id": 13, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195221, 47.6042938 ], [ -122.3195148, 47.6039469 ], [ -122.3195133, 47.6035829 ], [ -122.3194581, 47.6035243 ], [ -122.3193526, 47.6034661 ], [ -122.3182332, 47.6034579 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786731, "project_id": 13, "task_id": 250 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252107, 47.5993013 ], [ -122.326199, 47.5993018 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786746, "project_id": 13, "task_id": 325 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249271, 47.5993067 ], [ -122.3247096, 47.5993105 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786747, "project_id": 13, "task_id": 325 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249278, 47.5990851 ], [ -122.324711, 47.5990804 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786748, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252203, 47.5990976 ], [ -122.325229, 47.5991306 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786749, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251718, 47.5990718 ], [ -122.3251778, 47.598767 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786750, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251417, 47.5990629 ], [ -122.3251718, 47.5990718 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786751, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252203, 47.5990976 ], [ -122.3251718, 47.5990718 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786759, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3247096, 47.5993105 ], [ -122.3240616, 47.5993087 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786760, "project_id": 13, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324711, 47.5990804 ], [ -122.3240559, 47.5990796 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786764, "project_id": 13, "task_id": 65 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238877, 47.5999289 ], [ -122.3238811, 47.599789 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786765, "project_id": 13, "task_id": 65 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236488, 47.599931 ], [ -122.3236481, 47.5997819 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786766, "project_id": 13, "task_id": 66 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236481, 47.5997819 ], [ -122.3236456, 47.599653 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786767, "project_id": 13, "task_id": 66 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238811, 47.599789 ], [ -122.3238803, 47.599653 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786782, "project_id": 13, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236129, 47.6031703 ], [ -122.3229766, 47.6034515 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786783, "project_id": 13, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3243236, 47.6026966 ], [ -122.3239354, 47.6028573 ], [ -122.3228457, 47.6033089 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786784, "project_id": 13, "task_id": 66 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238803, 47.599653 ], [ -122.323881, 47.5995611 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786785, "project_id": 13, "task_id": 66 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236456, 47.599653 ], [ -122.3236476, 47.5995602 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786786, "project_id": 13, "task_id": 17 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323881, 47.5995611 ], [ -122.3238852, 47.5993807 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786787, "project_id": 13, "task_id": 17 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236476, 47.5995602 ], [ -122.3236497, 47.5993826 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786789, "project_id": 13, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236129, 47.6031703 ], [ -122.3240166, 47.6030089 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786790, "project_id": 13, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324308, 47.6031638 ], [ -122.3242578, 47.6031024 ], [ -122.3242391, 47.6030757 ], [ -122.3242298, 47.6030465 ], [ -122.3242298, 47.6030198 ], [ -122.3242239, 47.6029954 ], [ -122.3242146, 47.6029773 ], [ -122.3241901, 47.6029599 ], [ -122.3241516, 47.6029473 ], [ -122.3241165, 47.6029466 ], [ -122.3240862, 47.6029497 ], [ -122.3240652, 47.6029568 ], [ -122.3240552, 47.6029611 ], [ -122.3240482, 47.6029655 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786791, "project_id": 13, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240297, 47.6029496 ], [ -122.3239647, 47.6028844 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786792, "project_id": 13, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240482, 47.6029655 ], [ -122.3240297, 47.6029496 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786793, "project_id": 13, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240166, 47.6030089 ], [ -122.3240273, 47.6029855 ], [ -122.3240384, 47.6029726 ], [ -122.3240482, 47.6029655 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786794, "project_id": 13, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239647, 47.6028844 ], [ -122.3239354, 47.6028573 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786795, "project_id": 13, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249984, 47.6026041 ], [ -122.3246731, 47.6022944 ], [ -122.3246, 47.6022272 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786797, "project_id": 13, "task_id": 448 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327453, 47.603332 ], [ -122.3272735, 47.6031385 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786798, "project_id": 13, "task_id": 448 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3272912, 47.6034065 ], [ -122.3271499, 47.6032546 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786808, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239117, 47.5992614 ], [ -122.3239304, 47.5991288 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786809, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238368, 47.599337 ], [ -122.3236884, 47.599312 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786810, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236579, 47.5992846 ], [ -122.3236436, 47.5991195 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786811, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236523, 47.5993096 ], [ -122.3235013, 47.599307 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786812, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236497, 47.5993826 ], [ -122.3236523, 47.5993096 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786813, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236579, 47.5992846 ], [ -122.3236523, 47.5993096 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786814, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236523, 47.5993096 ], [ -122.3236884, 47.599312 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786815, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240616, 47.5993087 ], [ -122.3238932, 47.5993065 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786816, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239117, 47.5992614 ], [ -122.3238932, 47.5993065 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786817, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238368, 47.599337 ], [ -122.3238838, 47.5993366 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786818, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238838, 47.5993366 ], [ -122.3238852, 47.5993807 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786819, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238932, 47.5993065 ], [ -122.3238838, 47.5993366 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786831, "project_id": 13, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236965, 47.5990778 ], [ -122.3238357, 47.5990691 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786832, "project_id": 13, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236436, 47.5991195 ], [ -122.3236502, 47.5990835 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786833, "project_id": 13, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236502, 47.5990835 ], [ -122.3236965, 47.5990778 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786834, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236502, 47.5990835 ], [ -122.323651, 47.598752 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786835, "project_id": 13, "task_id": 85 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236502, 47.5990835 ], [ -122.3235403, 47.5990828 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786836, "project_id": 13, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238831, 47.5990765 ], [ -122.3238734, 47.5987549 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786837, "project_id": 13, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240559, 47.5990796 ], [ -122.3239314, 47.5990774 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786838, "project_id": 13, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238357, 47.5990691 ], [ -122.3238831, 47.5990765 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786839, "project_id": 13, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239304, 47.5991288 ], [ -122.3239314, 47.5990774 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786840, "project_id": 13, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239314, 47.5990774 ], [ -122.3238831, 47.5990765 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786841, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220918, 47.601296 ], [ -122.3217463, 47.6010239 ], [ -122.3216705, 47.6009783 ], [ -122.3216279, 47.6009634 ], [ -122.3215911, 47.6009586 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786844, "project_id": 13, "task_id": 261 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206072, 47.6035851 ], [ -122.3202174, 47.6035856 ], [ -122.3201859, 47.6035948 ], [ -122.3200974, 47.6035957 ], [ -122.3200503, 47.6035889 ], [ -122.3200161, 47.6035739 ], [ -122.3199986, 47.6035522 ], [ -122.3199893, 47.6035333 ], [ -122.3199872, 47.6035183 ], [ -122.319994, 47.6034966 ], [ -122.3200048, 47.6034815 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786845, "project_id": 13, "task_id": 132 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3198467, 47.6035026 ], [ -122.3199182, 47.6034665 ], [ -122.3199743, 47.6034669 ], [ -122.3200048, 47.6034815 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786846, "project_id": 13, "task_id": 261 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3198467, 47.6035026 ], [ -122.3201304, 47.6037782 ], [ -122.3205567, 47.6041954 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786847, "project_id": 13, "task_id": 261 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3200048, 47.6034815 ], [ -122.3200431, 47.6034636 ], [ -122.320076, 47.6034573 ], [ -122.3201826, 47.6034555 ], [ -122.3202209, 47.6034579 ], [ -122.3202787, 47.6034657 ], [ -122.320605, 47.6034673 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786848, "project_id": 13, "task_id": 191 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214508, 47.6011351 ], [ -122.3215384, 47.6012747 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786849, "project_id": 13, "task_id": 191 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3215911, 47.6009586 ], [ -122.3215481, 47.6009645 ], [ -122.3215102, 47.6009802 ], [ -122.3214711, 47.6010046 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786850, "project_id": 13, "task_id": 191 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214711, 47.6010046 ], [ -122.3214582, 47.6010542 ], [ -122.3214508, 47.6011351 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786851, "project_id": 13, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214711, 47.6010046 ], [ -122.321413, 47.6010219 ], [ -122.3213244, 47.6010163 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786852, "project_id": 13, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214508, 47.6011351 ], [ -122.3214118, 47.6010908 ], [ -122.3213244, 47.6010163 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786853, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322304, 47.5975938 ], [ -122.3217328, 47.5975955 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786854, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223478, 47.5974078 ], [ -122.3223508, 47.5969659 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786855, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223072, 47.5974366 ], [ -122.3216636, 47.5974405 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786856, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322578, 47.5982669 ], [ -122.3225818, 47.5976193 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786857, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226223, 47.5975923 ], [ -122.322784, 47.5975912 ], [ -122.3235932, 47.5975959 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786858, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223037, 47.59758 ], [ -122.322307, 47.5974482 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786859, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223725, 47.5974085 ], [ -122.3225636, 47.5973971 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786860, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225636, 47.5973971 ], [ -122.3225808, 47.5973964 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786861, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225807, 47.5974347 ], [ -122.3225808, 47.5973964 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786862, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225937, 47.5974348 ], [ -122.322593, 47.5974492 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786863, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322593, 47.5974492 ], [ -122.3226205, 47.5975825 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786864, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226205, 47.5975825 ], [ -122.3226223, 47.5975923 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786865, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322582, 47.5975925 ], [ -122.3226223, 47.5975923 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786866, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225818, 47.5976193 ], [ -122.322565, 47.5976189 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786867, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322565, 47.5976189 ], [ -122.322367, 47.597616 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786868, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225807, 47.5974347 ], [ -122.3225937, 47.5974348 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786869, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225818, 47.5976193 ], [ -122.322582, 47.5975925 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786870, "project_id": 13, "task_id": 272 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226061, 47.6019484 ], [ -122.3226341, 47.602311 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786884, "project_id": 13, "task_id": 272 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226341, 47.602311 ], [ -122.32263, 47.6023532 ], [ -122.3226052, 47.6024454 ], [ -122.3225683, 47.6025246 ], [ -122.3225126, 47.6025951 ], [ -122.322461, 47.6026408 ], [ -122.3223932, 47.6026883 ], [ -122.3223228, 47.602739 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786901, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206048, 47.6034505 ], [ -122.3206287, 47.6032052 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786902, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206072, 47.6035851 ], [ -122.3206163, 47.6035853 ], [ -122.3206131, 47.6038809 ], [ -122.320621, 47.6041891 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786903, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209033, 47.6035839 ], [ -122.3208491, 47.6035827 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786904, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209026, 47.6034467 ], [ -122.3209018, 47.6034021 ], [ -122.320901, 47.6031941 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786905, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209026, 47.6034467 ], [ -122.3208399, 47.6034467 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786906, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209033, 47.6035839 ], [ -122.3209026, 47.6034467 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786907, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320605, 47.6034673 ], [ -122.3206051, 47.6034899 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786908, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206474, 47.6034501 ], [ -122.3206048, 47.6034505 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786909, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320605, 47.6034673 ], [ -122.3206048, 47.6034505 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786910, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208399, 47.6034467 ], [ -122.3206474, 47.6034501 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786911, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206163, 47.6035853 ], [ -122.32065, 47.6035828 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786912, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206072, 47.6035851 ], [ -122.3206078, 47.6035615 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786913, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206078, 47.6035615 ], [ -122.3206051, 47.6034899 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786914, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.32065, 47.6035828 ], [ -122.3208491, 47.6035827 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786915, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3211804, 47.6034128 ], [ -122.3210995, 47.6033718 ], [ -122.3210531, 47.6033422 ], [ -122.3210294, 47.6033266 ], [ -122.3209709, 47.603269 ], [ -122.320901, 47.6031941 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786928, "project_id": 13, "task_id": 274 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209043, 47.6027965 ], [ -122.3209031, 47.6027754 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786929, "project_id": 13, "task_id": 274 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209031, 47.6027754 ], [ -122.3214655, 47.6027802 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786930, "project_id": 13, "task_id": 274 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206192, 47.6027585 ], [ -122.3206383, 47.602789 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786931, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208983, 47.6022059 ], [ -122.3209014, 47.6026216 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786932, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323671, 47.5976178 ], [ -122.3236509, 47.5976179 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786933, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235932, 47.5975959 ], [ -122.3236504, 47.5975969 ], [ -122.3236509, 47.5976179 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786934, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323594, 47.5975828 ], [ -122.3235932, 47.5975959 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786935, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236055, 47.5974421 ], [ -122.3236482, 47.5974422 ], [ -122.3236615, 47.5974345 ], [ -122.3236626, 47.5974089 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786936, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236626, 47.5974089 ], [ -122.323672, 47.5974089 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786940, "project_id": 13, "task_id": 447 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264381, 47.6019156 ], [ -122.3264407, 47.6019742 ], [ -122.3264534, 47.6020465 ], [ -122.3264747, 47.6021079 ], [ -122.3265042, 47.6021733 ], [ -122.3265443, 47.6022367 ], [ -122.3265835, 47.6022922 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786941, "project_id": 13, "task_id": 447 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3263352, 47.6019307 ], [ -122.3263383, 47.601981 ], [ -122.326349, 47.6020415 ], [ -122.3263677, 47.6021072 ], [ -122.326394, 47.6021706 ], [ -122.3264214, 47.6022198 ], [ -122.3264635, 47.6022808 ], [ -122.3265105, 47.6023475 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786942, "project_id": 13, "task_id": 447 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265105, 47.6023475 ], [ -122.3266005, 47.6024662 ], [ -122.3266909, 47.6025874 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786943, "project_id": 13, "task_id": 448 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265835, 47.6022922 ], [ -122.3266699, 47.6024082 ], [ -122.3267876, 47.6025692 ], [ -122.3268814, 47.6026961 ], [ -122.3270437, 47.6028814 ], [ -122.3272735, 47.6031385 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786944, "project_id": 13, "task_id": 448 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3271499, 47.6032546 ], [ -122.326966, 47.6030519 ], [ -122.3268434, 47.6029181 ], [ -122.3267278, 47.6028055 ], [ -122.3266297, 47.6027205 ], [ -122.3264126, 47.6025567 ], [ -122.3262994, 47.6024857 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786956, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251928, 47.5984413 ], [ -122.3251778, 47.598767 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786957, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251505, 47.5984408 ], [ -122.3251928, 47.5984413 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786958, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251938, 47.5984187 ], [ -122.3251928, 47.5984413 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786959, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251982, 47.5982855 ], [ -122.3251983, 47.5983077 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786960, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251246, 47.5982719 ], [ -122.3251771, 47.5982714 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786961, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251771, 47.5982714 ], [ -122.3251982, 47.5982855 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786962, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238734, 47.5987549 ], [ -122.3238777, 47.5984684 ], [ -122.3238782, 47.5984329 ], [ -122.3239243, 47.5984323 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786963, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239243, 47.5984323 ], [ -122.3239238, 47.5984223 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786964, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238777, 47.5984684 ], [ -122.3238663, 47.5984684 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786965, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323651, 47.598752 ], [ -122.3236515, 47.5984684 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786966, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238663, 47.5984684 ], [ -122.3236683, 47.5984683 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786967, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235971, 47.5984198 ], [ -122.3235946, 47.5982914 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786970, "project_id": 13, "task_id": 358 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251575, 47.6037391 ], [ -122.3255049, 47.6041192 ], [ -122.3255231, 47.6041433 ], [ -122.3255346, 47.6041713 ], [ -122.3255377, 47.6042062 ], [ -122.3255348, 47.6042276 ], [ -122.3255216, 47.6042568 ], [ -122.3254957, 47.6042835 ], [ -122.3254561, 47.6043093 ], [ -122.3253117, 47.6043821 ], [ -122.3253044, 47.6043888 ], [ -122.3253054, 47.6044006 ], [ -122.3253091, 47.6044391 ], [ -122.3253028, 47.6044635 ], [ -122.3250967, 47.6045589 ], [ -122.3250541, 47.6045624 ], [ -122.3249814, 47.6045688 ], [ -122.3248222, 47.6046413 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786971, "project_id": 13, "task_id": 358 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249218, 47.6037481 ], [ -122.325286, 47.6041479 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786972, "project_id": 13, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249984, 47.6026041 ], [ -122.3255021, 47.6030178 ], [ -122.3256481, 47.6031502 ], [ -122.3258801, 47.6033882 ], [ -122.326055, 47.6035703 ], [ -122.3261875, 47.6037371 ], [ -122.3263237, 47.6039915 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786975, "project_id": 13, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3213244, 47.6010163 ], [ -122.3212034, 47.6009621 ], [ -122.3211427, 47.6009424 ], [ -122.3210873, 47.6009376 ], [ -122.3208826, 47.6009365 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786976, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206383, 47.602789 ], [ -122.320634, 47.6029092 ], [ -122.3206287, 47.6032052 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786977, "project_id": 13, "task_id": 274 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209043, 47.6027965 ], [ -122.320901, 47.6031941 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786978, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322529, 47.5984401 ], [ -122.322377, 47.5984541 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786979, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322341, 47.5984045 ], [ -122.322337, 47.5983054 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786980, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322587, 47.5984045 ], [ -122.322578, 47.5982966 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786981, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322543, 47.5982668 ], [ -122.322388, 47.5982726 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786988, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220435, 47.6027762 ], [ -122.3214655, 47.6027802 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786989, "project_id": 13, "task_id": 188 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225766, 47.5990718 ], [ -122.322745, 47.5990726 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786990, "project_id": 13, "task_id": 195 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225708, 47.5992771 ], [ -122.3225726, 47.5992928 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786991, "project_id": 13, "task_id": 85 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235013, 47.599307 ], [ -122.3225726, 47.5992928 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786992, "project_id": 13, "task_id": 85 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235403, 47.5990828 ], [ -122.3231875, 47.5990827 ], [ -122.322745, 47.5990726 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787004, "project_id": 13, "task_id": 46 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208826, 47.6009365 ], [ -122.3205362, 47.6009362 ], [ -122.3200577, 47.6009357 ], [ -122.3198277, 47.600936 ], [ -122.3197739, 47.6009381 ], [ -122.3197257, 47.600942 ], [ -122.3196778, 47.6009482 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787005, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3199945, 47.600772 ], [ -122.3205147, 47.600775 ], [ -122.3205356, 47.6007751 ], [ -122.3205806, 47.6007754 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787240, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209091, 47.6048715 ], [ -122.3209159, 47.6048634 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787256, "project_id": 13, "task_id": 138 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182253, 47.6027547 ], [ -122.3185602, 47.6027548 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787257, "project_id": 13, "task_id": 138 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3185786, 47.6026297 ], [ -122.3182139, 47.6026284 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787292, "project_id": 13, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324308, 47.6031638 ], [ -122.32452, 47.6033933 ], [ -122.324578, 47.6034614 ], [ -122.3245796, 47.6034827 ], [ -122.3245773, 47.6035159 ], [ -122.3245803, 47.6035341 ], [ -122.3245904, 47.6035502 ], [ -122.3247344, 47.6037041 ], [ -122.3247539, 47.6037167 ], [ -122.3248052, 47.6037298 ], [ -122.3248955, 47.6037406 ], [ -122.3249218, 47.6037481 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787293, "project_id": 13, "task_id": 144 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251575, 47.6037391 ], [ -122.3251322, 47.6037178 ], [ -122.3250947, 47.6036975 ], [ -122.3250122, 47.6036477 ], [ -122.3250048, 47.6036369 ], [ -122.3248564, 47.6034572 ], [ -122.3248179, 47.6034213 ], [ -122.3247994, 47.603411 ], [ -122.3247616, 47.603398 ], [ -122.3246803, 47.6033819 ], [ -122.3246563, 47.6033752 ], [ -122.3246289, 47.6033626 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787301, "project_id": 13, "task_id": 144 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251575, 47.6037391 ], [ -122.3251065, 47.6036924 ], [ -122.3250244, 47.6036406 ], [ -122.3248475, 47.6034421 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787302, "project_id": 13, "task_id": 358 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249218, 47.6037481 ], [ -122.3247553, 47.6037147 ], [ -122.3246864, 47.6036435 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789074, "project_id": 13, "task_id": 366 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328265, 47.6042104 ], [ -122.3282491, 47.6041965 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789075, "project_id": 13, "task_id": 366 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3282779, 47.6041895 ], [ -122.3282491, 47.6041965 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789076, "project_id": 13, "task_id": 366 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3282491, 47.6041965 ], [ -122.3280778, 47.6042831 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789077, "project_id": 13, "task_id": 240 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3292479, 47.6035611 ], [ -122.3287267, 47.6030312 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789078, "project_id": 13, "task_id": 534 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329023, 47.6036443 ], [ -122.3290132, 47.6036344 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789079, "project_id": 13, "task_id": 240 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3290132, 47.6036344 ], [ -122.3285106, 47.603102 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789080, "project_id": 13, "task_id": 533 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303741, 47.6031249 ], [ -122.330343, 47.6030868 ], [ -122.3298519, 47.6025634 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789081, "project_id": 13, "task_id": 525 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3293948, 47.6020343 ], [ -122.3293023, 47.6019325 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789082, "project_id": 13, "task_id": 525 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329579, 47.6019614 ], [ -122.3294387, 47.6020545 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789083, "project_id": 13, "task_id": 525 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3295349, 47.6019219 ], [ -122.3293023, 47.6019325 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789084, "project_id": 13, "task_id": 526 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3294184, 47.6016419 ], [ -122.3290231, 47.601648 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789085, "project_id": 13, "task_id": 526 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3294225, 47.6017954 ], [ -122.3292678, 47.6018009 ], [ -122.329207, 47.6018245 ], [ -122.3291284, 47.6018551 ], [ -122.3290445, 47.6018882 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789086, "project_id": 13, "task_id": 524 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291284, 47.6018551 ], [ -122.329066, 47.6017997 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789087, "project_id": 13, "task_id": 524 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329066, 47.6017997 ], [ -122.3290406, 47.6017978 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789089, "project_id": 13, "task_id": 525 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3293023, 47.6019325 ], [ -122.3292822, 47.6019284 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789090, "project_id": 13, "task_id": 452 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3285957, 47.6028731 ], [ -122.3280758, 47.6023056 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789091, "project_id": 13, "task_id": 446 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328364, 47.6029742 ], [ -122.3278399, 47.6023806 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789092, "project_id": 13, "task_id": 446 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278399, 47.6023806 ], [ -122.327816, 47.602359 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789093, "project_id": 13, "task_id": 446 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278399, 47.6023806 ], [ -122.327855, 47.6023722 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789094, "project_id": 13, "task_id": 446 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327816, 47.602359 ], [ -122.327741, 47.6022844 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789095, "project_id": 13, "task_id": 446 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327855, 47.6023722 ], [ -122.3280577, 47.6022973 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789096, "project_id": 13, "task_id": 446 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327762, 47.6022481 ], [ -122.327923, 47.6021842 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789097, "project_id": 13, "task_id": 446 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327741, 47.6022844 ], [ -122.3277212, 47.6022633 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789098, "project_id": 13, "task_id": 446 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327762, 47.6022481 ], [ -122.3277212, 47.6022633 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789099, "project_id": 13, "task_id": 446 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277212, 47.6022633 ], [ -122.3276488, 47.6022052 ], [ -122.3275842, 47.6021445 ], [ -122.3275475, 47.6020911 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789100, "project_id": 13, "task_id": 446 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327966, 47.6021803 ], [ -122.3280577, 47.6022973 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789101, "project_id": 13, "task_id": 459 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3282522, 47.6020514 ], [ -122.3279519, 47.6021695 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789102, "project_id": 13, "task_id": 446 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3279519, 47.6021695 ], [ -122.327966, 47.6021803 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789103, "project_id": 13, "task_id": 446 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3279519, 47.6021695 ], [ -122.327923, 47.6021842 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789104, "project_id": 13, "task_id": 446 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3279519, 47.6021695 ], [ -122.3277972, 47.602002 ], [ -122.3277978, 47.601975 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789240, "project_id": 13, "task_id": 369 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3281275, 47.6040527 ], [ -122.3281076, 47.604039 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789241, "project_id": 13, "task_id": 369 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3280778, 47.6042831 ], [ -122.3280602, 47.6042885 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789242, "project_id": 13, "task_id": 369 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3280602, 47.6042885 ], [ -122.3280944, 47.6043286 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789243, "project_id": 13, "task_id": 369 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3279189, 47.6040992 ], [ -122.3279272, 47.6041118 ], [ -122.3279253, 47.6041243 ], [ -122.3279152, 47.6041341 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789244, "project_id": 13, "task_id": 449 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3283072, 47.6021984 ], [ -122.3280758, 47.6023056 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789245, "project_id": 13, "task_id": 449 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3280758, 47.6023056 ], [ -122.3280577, 47.6022973 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789246, "project_id": 13, "task_id": 143 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236832, 47.6017867 ], [ -122.3232573, 47.6017916 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789247, "project_id": 13, "task_id": 15 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323893, 47.5999571 ], [ -122.3238806, 47.5999608 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789248, "project_id": 13, "task_id": 508 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3309579, 47.6020956 ], [ -122.3307499, 47.6018998 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789249, "project_id": 13, "task_id": 505 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3312022, 47.6023466 ], [ -122.3309579, 47.6020956 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789250, "project_id": 13, "task_id": 531 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3309223, 47.6021035 ], [ -122.3307472, 47.6021612 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789251, "project_id": 13, "task_id": 531 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3307472, 47.6021612 ], [ -122.3307197, 47.6021723 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789252, "project_id": 13, "task_id": 531 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3309579, 47.6020956 ], [ -122.3309223, 47.6021035 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789253, "project_id": 13, "task_id": 536 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299133, 47.6043084 ], [ -122.3296364, 47.6040015 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789254, "project_id": 13, "task_id": 362 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299133, 47.6043084 ], [ -122.329896, 47.6043139 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789255, "project_id": 13, "task_id": 362 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329708, 47.6043841 ], [ -122.3296904, 47.6043942 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789256, "project_id": 13, "task_id": 362 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329896, 47.6043139 ], [ -122.330008, 47.6044228 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789257, "project_id": 13, "task_id": 362 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3297001, 47.6044154 ], [ -122.329716, 47.6045277 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789258, "project_id": 13, "task_id": 362 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329754, 47.6045463 ], [ -122.3298692, 47.6045896 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789259, "project_id": 13, "task_id": 362 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329996, 47.6044592 ], [ -122.329914, 47.6045658 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789260, "project_id": 13, "task_id": 362 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330035, 47.6044428 ], [ -122.330008, 47.6044228 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789261, "project_id": 13, "task_id": 362 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3300197, 47.6044499 ], [ -122.329996, 47.6044592 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789262, "project_id": 13, "task_id": 362 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3296442, 47.6046001 ], [ -122.3297287, 47.6045485 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789263, "project_id": 13, "task_id": 362 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3296442, 47.6046001 ], [ -122.3293564, 47.6047149 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789264, "project_id": 13, "task_id": 362 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3297287, 47.6045485 ], [ -122.329716, 47.6045277 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789265, "project_id": 13, "task_id": 362 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3297287, 47.6045485 ], [ -122.329754, 47.6045463 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789266, "project_id": 13, "task_id": 362 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3297001, 47.6044154 ], [ -122.3296888, 47.604407 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789267, "project_id": 13, "task_id": 362 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3296904, 47.6043942 ], [ -122.3296888, 47.604407 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789268, "project_id": 13, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3309254, 47.6040809 ], [ -122.3309037, 47.6040728 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789269, "project_id": 13, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3308, 47.6039175 ], [ -122.3307798, 47.6039246 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789270, "project_id": 13, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3307641, 47.6039534 ], [ -122.330786, 47.6039556 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789273, "project_id": 13, "task_id": 387 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3302042, 47.604927 ], [ -122.3299147, 47.6045996 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789274, "project_id": 13, "task_id": 387 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329914, 47.6045658 ], [ -122.3299147, 47.6045996 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789275, "project_id": 13, "task_id": 362 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299147, 47.6045996 ], [ -122.3298692, 47.6045896 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789289, "project_id": 13, "task_id": 522 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3302191, 47.601586 ], [ -122.3303892, 47.6016234 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789290, "project_id": 13, "task_id": 523 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301793, 47.6015731 ], [ -122.330175, 47.6014699 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789291, "project_id": 13, "task_id": 522 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3302191, 47.601586 ], [ -122.3301793, 47.6015731 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789292, "project_id": 13, "task_id": 522 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301793, 47.6015731 ], [ -122.3301801, 47.6015964 ], [ -122.3301704, 47.6016022 ], [ -122.3301385, 47.6015881 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789293, "project_id": 13, "task_id": 508 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3307202, 47.6018193 ], [ -122.3303395, 47.6018057 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789294, "project_id": 13, "task_id": 508 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3305535, 47.6016439 ], [ -122.3304081, 47.601639 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789295, "project_id": 13, "task_id": 522 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3304081, 47.601639 ], [ -122.3303892, 47.6016234 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789296, "project_id": 13, "task_id": 522 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303395, 47.6018057 ], [ -122.3303162, 47.6018057 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789297, "project_id": 13, "task_id": 522 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3304475, 47.6019076 ], [ -122.3303505, 47.6018181 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789298, "project_id": 13, "task_id": 522 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303505, 47.6018181 ], [ -122.3303395, 47.6018057 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789299, "project_id": 13, "task_id": 505 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3312022, 47.6023466 ], [ -122.3314434, 47.6026162 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789300, "project_id": 13, "task_id": 505 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314434, 47.6026162 ], [ -122.3314552, 47.6026324 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789301, "project_id": 13, "task_id": 505 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3316015, 47.6027994 ], [ -122.3315837, 47.6027961 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789302, "project_id": 13, "task_id": 505 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3316015, 47.6027994 ], [ -122.3315837, 47.6027961 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789303, "project_id": 13, "task_id": 522 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301385, 47.6015881 ], [ -122.3301009, 47.6015647 ], [ -122.3300194, 47.6015132 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789304, "project_id": 13, "task_id": 521 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301009, 47.6015647 ], [ -122.3300827, 47.6015781 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789305, "project_id": 13, "task_id": 521 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3300827, 47.6015781 ], [ -122.3300058, 47.6016361 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789306, "project_id": 13, "task_id": 521 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3300047, 47.6016612 ], [ -122.3300953, 47.6017866 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789307, "project_id": 13, "task_id": 521 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299954, 47.6016515 ], [ -122.3298955, 47.6016528 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789308, "project_id": 13, "task_id": 521 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299954, 47.6016515 ], [ -122.3300036, 47.601648 ], [ -122.3299979, 47.6016422 ], [ -122.3299049, 47.6016178 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789309, "project_id": 13, "task_id": 521 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299954, 47.6016515 ], [ -122.3300047, 47.6016612 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789310, "project_id": 13, "task_id": 521 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299979, 47.6016422 ], [ -122.3300058, 47.6016361 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789311, "project_id": 13, "task_id": 521 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3300953, 47.6017866 ], [ -122.3299362, 47.6017954 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789312, "project_id": 13, "task_id": 521 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299204, 47.6018009 ], [ -122.3298952, 47.6018084 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789313, "project_id": 13, "task_id": 521 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299204, 47.6018009 ], [ -122.3299195, 47.6017935 ], [ -122.3299189, 47.6017879 ], [ -122.3298967, 47.6017866 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789314, "project_id": 13, "task_id": 521 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299362, 47.6017954 ], [ -122.3299195, 47.6017935 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789315, "project_id": 13, "task_id": 521 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299611, 47.6019338 ], [ -122.3301343, 47.6018942 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789316, "project_id": 13, "task_id": 521 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301114, 47.6017982 ], [ -122.3300953, 47.6017866 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789317, "project_id": 13, "task_id": 426 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3323565, 47.6023014 ], [ -122.332208, 47.6021279 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789318, "project_id": 13, "task_id": 430 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332208, 47.6021279 ], [ -122.3321244, 47.6020334 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789319, "project_id": 13, "task_id": 357 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3321244, 47.6020334 ], [ -122.3320201, 47.6019039 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789320, "project_id": 13, "task_id": 428 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3325695, 47.602213 ], [ -122.3323875, 47.6022894 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789321, "project_id": 13, "task_id": 428 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3326255, 47.6022183 ], [ -122.332708, 47.6023041 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789322, "project_id": 13, "task_id": 355 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3326904, 47.6023385 ], [ -122.332501, 47.6024086 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789323, "project_id": 13, "task_id": 428 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3324544, 47.6024084 ], [ -122.3323741, 47.6023206 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789324, "project_id": 13, "task_id": 428 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3326255, 47.6022183 ], [ -122.3325996, 47.602201 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789325, "project_id": 13, "task_id": 428 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3325996, 47.602201 ], [ -122.3325695, 47.602213 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789326, "project_id": 13, "task_id": 355 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332708, 47.6023041 ], [ -122.3327229, 47.6023243 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789327, "project_id": 13, "task_id": 426 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3323875, 47.6022894 ], [ -122.3323565, 47.6023014 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789328, "project_id": 13, "task_id": 426 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3323741, 47.6023206 ], [ -122.3323619, 47.6023069 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789329, "project_id": 13, "task_id": 428 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332501, 47.6024086 ], [ -122.3324714, 47.6024256 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789330, "project_id": 13, "task_id": 428 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3324714, 47.6024256 ], [ -122.3324544, 47.6024084 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789350, "project_id": 13, "task_id": 191 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214045, 47.6012763 ], [ -122.3213537, 47.6012329 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789351, "project_id": 13, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3213537, 47.6012329 ], [ -122.321248, 47.6011731 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789352, "project_id": 13, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321248, 47.6011731 ], [ -122.3211146, 47.6011344 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789353, "project_id": 13, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3211146, 47.6011344 ], [ -122.3209642, 47.6011303 ], [ -122.3208933, 47.6011284 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789354, "project_id": 13, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3212614, 47.6013163 ], [ -122.3212085, 47.601257 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789355, "project_id": 13, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3212085, 47.601257 ], [ -122.3211019, 47.6011801 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789356, "project_id": 13, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3211019, 47.6011801 ], [ -122.3209642, 47.6011303 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789357, "project_id": 13, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3329541, 47.6046207 ], [ -122.3326644, 47.6043131 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789359, "project_id": 13, "task_id": 521 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3298955, 47.6016528 ], [ -122.3294184, 47.6016419 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789360, "project_id": 13, "task_id": 521 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3298952, 47.6018084 ], [ -122.3297402, 47.6018708 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789361, "project_id": 13, "task_id": 527 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3297402, 47.6018708 ], [ -122.3296494, 47.6019218 ], [ -122.329579, 47.6019614 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789362, "project_id": 13, "task_id": 521 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3298967, 47.6017866 ], [ -122.3294225, 47.6017954 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789363, "project_id": 13, "task_id": 525 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3296494, 47.6019218 ], [ -122.3295349, 47.6019219 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789364, "project_id": 13, "task_id": 525 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3292822, 47.6019284 ], [ -122.3292251, 47.601846 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789365, "project_id": 13, "task_id": 524 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3292251, 47.601846 ], [ -122.3291643, 47.6017645 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789366, "project_id": 13, "task_id": 524 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291643, 47.6017645 ], [ -122.3291194, 47.6016696 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789367, "project_id": 13, "task_id": 524 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291194, 47.6016696 ], [ -122.3291109, 47.6016138 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789368, "project_id": 13, "task_id": 526 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3287486, 47.6016707 ], [ -122.3287315, 47.6017557 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789369, "project_id": 13, "task_id": 526 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3290406, 47.6017978 ], [ -122.3288266, 47.6018026 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789370, "project_id": 13, "task_id": 526 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288266, 47.6018026 ], [ -122.32877, 47.6017926 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789371, "project_id": 13, "task_id": 526 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328792, 47.6018244 ], [ -122.3287071, 47.6018583 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789372, "project_id": 13, "task_id": 526 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.32877, 47.6017926 ], [ -122.328731, 47.6017927 ], [ -122.3286731, 47.601793 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789373, "project_id": 13, "task_id": 526 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3287315, 47.6017557 ], [ -122.328731, 47.6017927 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789374, "project_id": 13, "task_id": 526 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288266, 47.6018026 ], [ -122.328792, 47.6018244 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789375, "project_id": 13, "task_id": 526 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288554, 47.6016484 ], [ -122.3287492, 47.601649 ], [ -122.3286983, 47.6016492 ], [ -122.3285926, 47.6016467 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789376, "project_id": 13, "task_id": 526 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3290231, 47.601648 ], [ -122.3288554, 47.6016484 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789377, "project_id": 13, "task_id": 526 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3287486, 47.6016707 ], [ -122.3287492, 47.601649 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789378, "project_id": 13, "task_id": 526 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3290445, 47.6018882 ], [ -122.3287835, 47.6019931 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789379, "project_id": 13, "task_id": 459 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3285926, 47.6016467 ], [ -122.3281474, 47.6016465 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789380, "project_id": 13, "task_id": 459 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3286731, 47.601793 ], [ -122.3281455, 47.6017933 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789381, "project_id": 13, "task_id": 459 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3287071, 47.6018583 ], [ -122.3282522, 47.6020514 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789382, "project_id": 13, "task_id": 459 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3287835, 47.6019931 ], [ -122.3283072, 47.6021984 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789383, "project_id": 13, "task_id": 457 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275455, 47.6015079 ], [ -122.3275491, 47.6012933 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789384, "project_id": 13, "task_id": 457 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277847, 47.6012985 ], [ -122.3277799, 47.6016272 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789385, "project_id": 13, "task_id": 459 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3281474, 47.6016465 ], [ -122.3276106, 47.6016444 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789386, "project_id": 13, "task_id": 446 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275475, 47.6020911 ], [ -122.3275109, 47.6019721 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789387, "project_id": 13, "task_id": 457 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277978, 47.601975 ], [ -122.3277942, 47.6017938 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789388, "project_id": 13, "task_id": 457 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277942, 47.6017938 ], [ -122.3277799, 47.6016272 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789389, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3205147, 47.600775 ], [ -122.3204172, 47.6004348 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789390, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3204172, 47.6004348 ], [ -122.3201729, 47.6003933 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789391, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3201729, 47.6003933 ], [ -122.3201825, 47.600363 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789392, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3201825, 47.600363 ], [ -122.3199686, 47.6003272 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789393, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3205362, 47.6009362 ], [ -122.3205368, 47.6008777 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789394, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3205368, 47.6008777 ], [ -122.3205349, 47.6008097 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789395, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3205349, 47.6008097 ], [ -122.3205356, 47.6007751 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789396, "project_id": 13, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208933, 47.6011284 ], [ -122.3206583, 47.6011286 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789397, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208451, 47.6015806 ], [ -122.3206235, 47.6011273 ], [ -122.3206075, 47.6010923 ], [ -122.3205362, 47.6009362 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789398, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206583, 47.6011286 ], [ -122.3206235, 47.6011273 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789399, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206075, 47.6010923 ], [ -122.3203275, 47.6010951 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789400, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3203275, 47.6010951 ], [ -122.3200797, 47.6011118 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789401, "project_id": 13, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3293564, 47.6047149 ], [ -122.3289678, 47.6048805 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789402, "project_id": 13, "task_id": 124 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3295585, 47.605444 ], [ -122.3294333, 47.6055003 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789403, "project_id": 13, "task_id": 242 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299208, 47.5992713 ], [ -122.3297896, 47.5991149 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789404, "project_id": 13, "task_id": 242 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299312, 47.5992956 ], [ -122.3299208, 47.5992713 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789405, "project_id": 13, "task_id": 242 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3298984, 47.5993123 ], [ -122.3297259, 47.5993355 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789406, "project_id": 13, "task_id": 122 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299689, 47.5997065 ], [ -122.3296751, 47.599361 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789407, "project_id": 13, "task_id": 242 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3297259, 47.5993355 ], [ -122.3296751, 47.599361 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789408, "project_id": 13, "task_id": 122 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301047, 47.5995688 ], [ -122.3299091, 47.5993337 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789409, "project_id": 13, "task_id": 242 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299091, 47.5993337 ], [ -122.3298984, 47.5993123 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789410, "project_id": 13, "task_id": 242 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299312, 47.5992956 ], [ -122.3299091, 47.5993337 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789411, "project_id": 13, "task_id": 523 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330396, 47.6014718 ], [ -122.3303799, 47.6012601 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789412, "project_id": 13, "task_id": 523 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303799, 47.6011878 ], [ -122.330381, 47.6010525 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789413, "project_id": 13, "task_id": 355 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332849, 47.6022621 ], [ -122.3327229, 47.6023243 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789414, "project_id": 13, "task_id": 355 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330322, 47.6026874 ], [ -122.3327229, 47.6023243 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789415, "project_id": 13, "task_id": 355 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327229, 47.6023243 ], [ -122.3326904, 47.6023385 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789416, "project_id": 13, "task_id": 354 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3333425, 47.6030398 ], [ -122.3332484, 47.6029367 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789417, "project_id": 13, "task_id": 354 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330397, 47.6030026 ], [ -122.3332484, 47.6029367 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789418, "project_id": 13, "task_id": 354 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3331406, 47.6031275 ], [ -122.3331215, 47.60314 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789419, "project_id": 13, "task_id": 354 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330976, 47.6031356 ], [ -122.3331215, 47.60314 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789420, "project_id": 13, "task_id": 354 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330208, 47.6030375 ], [ -122.3330087, 47.6030197 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789421, "project_id": 13, "task_id": 354 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330397, 47.6030026 ], [ -122.3330087, 47.6030197 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789422, "project_id": 13, "task_id": 354 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3332411, 47.6029297 ], [ -122.3330322, 47.6026874 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789423, "project_id": 13, "task_id": 354 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3334265, 47.6028468 ], [ -122.3332411, 47.6029297 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789424, "project_id": 13, "task_id": 354 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3332484, 47.6029367 ], [ -122.3332411, 47.6029297 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789425, "project_id": 13, "task_id": 499 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333358, 47.6030404 ], [ -122.3333425, 47.6030398 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789426, "project_id": 13, "task_id": 516 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343382, 47.6040847 ], [ -122.3340621, 47.6037377 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789427, "project_id": 13, "task_id": 516 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340621, 47.6037377 ], [ -122.3340161, 47.6037271 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789428, "project_id": 13, "task_id": 516 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3345563, 47.604335 ], [ -122.3343382, 47.6040847 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789429, "project_id": 13, "task_id": 515 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.334522, 47.6043433 ], [ -122.3343183, 47.604428 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789430, "project_id": 13, "task_id": 515 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3346712, 47.6044522 ], [ -122.334578, 47.6043536 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789431, "project_id": 13, "task_id": 515 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3346488, 47.6044808 ], [ -122.3344646, 47.6045531 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789432, "project_id": 13, "task_id": 515 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3344172, 47.6045756 ], [ -122.3344941, 47.6046667 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789433, "project_id": 13, "task_id": 515 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3344646, 47.6045531 ], [ -122.3344172, 47.6045756 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789434, "project_id": 13, "task_id": 515 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3344172, 47.6045756 ], [ -122.3343885, 47.6045638 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789435, "project_id": 13, "task_id": 515 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3342854, 47.6044471 ], [ -122.3343246, 47.6044807 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789436, "project_id": 13, "task_id": 515 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3349444, 47.6041756 ], [ -122.3345563, 47.604335 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789437, "project_id": 13, "task_id": 515 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343183, 47.604428 ], [ -122.3342854, 47.6044471 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789438, "project_id": 13, "task_id": 515 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.334578, 47.6043536 ], [ -122.3345563, 47.604335 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789439, "project_id": 13, "task_id": 515 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3345563, 47.604335 ], [ -122.334522, 47.6043433 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789625, "project_id": 13, "task_id": 519 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3346712, 47.6044522 ], [ -122.3346932, 47.60448 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789626, "project_id": 13, "task_id": 519 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3346932, 47.60448 ], [ -122.3346488, 47.6044808 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789627, "project_id": 13, "task_id": 410 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354499, 47.6051353 ], [ -122.335338, 47.6051735 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789628, "project_id": 13, "task_id": 410 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335338, 47.6051735 ], [ -122.3353415, 47.6051901 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789629, "project_id": 13, "task_id": 410 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335338, 47.6051735 ], [ -122.3353263, 47.6051615 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789644, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3359805, 47.6058758 ], [ -122.3359695, 47.6058604 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789645, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3362032, 47.6061435 ], [ -122.3359703, 47.605889 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789646, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3359805, 47.6058758 ], [ -122.3359703, 47.605889 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789647, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3359703, 47.605889 ], [ -122.3359467, 47.6058966 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789648, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360973, 47.6063861 ], [ -122.3357323, 47.6059988 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789649, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3357323, 47.6059988 ], [ -122.3357153, 47.6059981 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789650, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3363102, 47.6055733 ], [ -122.3358759, 47.6057492 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789651, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358759, 47.6057492 ], [ -122.3358579, 47.6057451 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789663, "project_id": 13, "task_id": 100 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3362413, 47.6065921 ], [ -122.3361853, 47.6066144 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789664, "project_id": 13, "task_id": 100 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3362526, 47.6065675 ], [ -122.3360973, 47.6063861 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789665, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3365057, 47.606463 ], [ -122.3362032, 47.6061435 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789666, "project_id": 13, "task_id": 100 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3361853, 47.6066144 ], [ -122.3358052, 47.6067683 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789667, "project_id": 13, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358052, 47.6067683 ], [ -122.3354051, 47.6069409 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789674, "project_id": 13, "task_id": 300 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3348626, 47.6063517 ], [ -122.3348672, 47.6063671 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789675, "project_id": 13, "task_id": 166 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340875, 47.6054963 ], [ -122.3340554, 47.6055207 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789676, "project_id": 13, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3335586, 47.6049397 ], [ -122.333537, 47.6049347 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789677, "project_id": 13, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3332065, 47.604896 ], [ -122.3330087, 47.6046725 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789678, "project_id": 13, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333215, 47.6048952 ], [ -122.3332065, 47.604896 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789710, "project_id": 13, "task_id": 40 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330087, 47.6046725 ], [ -122.3329541, 47.6046207 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789742, "project_id": 13, "task_id": 259 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3323196, 47.6073004 ], [ -122.3319817, 47.6074349 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789743, "project_id": 13, "task_id": 387 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3302042, 47.604927 ], [ -122.3302119, 47.6049364 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789744, "project_id": 13, "task_id": 387 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3302119, 47.6049364 ], [ -122.3302946, 47.6050671 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789745, "project_id": 13, "task_id": 386 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3305175, 47.6050247 ], [ -122.3303501, 47.6051297 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789746, "project_id": 13, "task_id": 386 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303501, 47.6051297 ], [ -122.3304738, 47.605228 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789747, "project_id": 13, "task_id": 365 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33034, 47.6051219 ], [ -122.3295585, 47.605444 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789748, "project_id": 13, "task_id": 386 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33034, 47.6051219 ], [ -122.3303043, 47.6050866 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789749, "project_id": 13, "task_id": 386 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3302946, 47.6050671 ], [ -122.3303043, 47.6050866 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789750, "project_id": 13, "task_id": 386 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33034, 47.6051219 ], [ -122.3303501, 47.6051297 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789751, "project_id": 13, "task_id": 386 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3306597, 47.6051677 ], [ -122.3306496, 47.6051659 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789752, "project_id": 13, "task_id": 386 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3304738, 47.605228 ], [ -122.3304608, 47.6052383 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789753, "project_id": 13, "task_id": 386 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3305603, 47.6050355 ], [ -122.3305426, 47.6050168 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789768, "project_id": 13, "task_id": 259 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3319817, 47.6074349 ], [ -122.331581, 47.6075458 ], [ -122.331391, 47.6076219 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789769, "project_id": 13, "task_id": 478 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3315076, 47.6077489 ], [ -122.3314155, 47.6076455 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789770, "project_id": 13, "task_id": 478 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314955, 47.6077741 ], [ -122.3313629, 47.6078311 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789771, "project_id": 13, "task_id": 478 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3315179, 47.6077647 ], [ -122.3315076, 47.6077489 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789772, "project_id": 13, "task_id": 478 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3315179, 47.6077647 ], [ -122.3314955, 47.6077741 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789773, "project_id": 13, "task_id": 478 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314029, 47.6079481 ], [ -122.3313284, 47.6078439 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789774, "project_id": 13, "task_id": 478 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3313629, 47.6078311 ], [ -122.3313284, 47.6078439 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789775, "project_id": 13, "task_id": 478 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3313284, 47.6078439 ], [ -122.3313163, 47.6078474 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789776, "project_id": 13, "task_id": 478 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314155, 47.6076455 ], [ -122.331391, 47.6076219 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789777, "project_id": 13, "task_id": 172 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3315427, 47.6081153 ], [ -122.3314029, 47.6079481 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789778, "project_id": 13, "task_id": 172 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317414, 47.6083152 ], [ -122.3317055, 47.608279 ], [ -122.3316526, 47.6082259 ], [ -122.3315427, 47.6081153 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789779, "project_id": 13, "task_id": 495 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3335157, 47.6019843 ], [ -122.332849, 47.6022621 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789780, "project_id": 13, "task_id": 354 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3339945, 47.6026046 ], [ -122.3334265, 47.6028468 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789816, "project_id": 13, "task_id": 4 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288712, 47.597476 ], [ -122.3288696, 47.5975722 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789817, "project_id": 13, "task_id": 4 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291922, 47.5976014 ], [ -122.3289202, 47.5976028 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789818, "project_id": 13, "task_id": 4 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288816, 47.5976984 ], [ -122.3288832, 47.597601 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789819, "project_id": 13, "task_id": 4 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3289202, 47.5976028 ], [ -122.3288832, 47.597601 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789820, "project_id": 13, "task_id": 4 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288832, 47.597601 ], [ -122.3288696, 47.5975722 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789821, "project_id": 13, "task_id": 4 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288725, 47.5974552 ], [ -122.3288712, 47.597476 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789822, "project_id": 13, "task_id": 4 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3292152, 47.5976009 ], [ -122.3291922, 47.5976014 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789823, "project_id": 13, "task_id": 4 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328878, 47.5981627 ], [ -122.3288816, 47.5976984 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789827, "project_id": 13, "task_id": 69 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3292451, 47.5957609 ], [ -122.3292409, 47.5952855 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789833, "project_id": 13, "task_id": 75 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3272664, 47.5957414 ], [ -122.3272654, 47.5957256 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789834, "project_id": 13, "task_id": 74 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3272654, 47.5957256 ], [ -122.326845, 47.5955228 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789855, "project_id": 13, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330381, 47.6010525 ], [ -122.3303838, 47.6009713 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789856, "project_id": 13, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301744, 47.6008103 ], [ -122.3301705, 47.6005793 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789857, "project_id": 13, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303921, 47.600811 ], [ -122.3303833, 47.6005819 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789858, "project_id": 13, "task_id": 237 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301705, 47.6005793 ], [ -122.3301738, 47.6001188 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789859, "project_id": 13, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303833, 47.6005819 ], [ -122.3303968, 47.6001476 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789860, "project_id": 13, "task_id": 237 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3305318, 47.600317 ], [ -122.3303968, 47.6001476 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789861, "project_id": 13, "task_id": 232 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330179, 47.5999793 ], [ -122.3301698, 47.6000955 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789862, "project_id": 13, "task_id": 232 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330216, 47.6001262 ], [ -122.3303698, 47.6001415 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789863, "project_id": 13, "task_id": 232 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301738, 47.6001188 ], [ -122.3299611, 47.6001164 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789864, "project_id": 13, "task_id": 232 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330216, 47.6001262 ], [ -122.3301738, 47.6001188 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789865, "project_id": 13, "task_id": 232 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301738, 47.6001188 ], [ -122.3301698, 47.6000955 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789870, "project_id": 13, "task_id": 372 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3297058, 47.5990611 ], [ -122.32921, 47.5985231 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789871, "project_id": 13, "task_id": 379 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3293068, 47.5989594 ], [ -122.3292597, 47.5989004 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789872, "project_id": 13, "task_id": 379 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3292597, 47.5989004 ], [ -122.329235, 47.598887 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789873, "project_id": 13, "task_id": 379 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329235, 47.598887 ], [ -122.3292033, 47.5988883 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789876, "project_id": 13, "task_id": 381 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3292033, 47.5988883 ], [ -122.3291861, 47.5989031 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789877, "project_id": 13, "task_id": 381 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291861, 47.5989031 ], [ -122.3291874, 47.5990022 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789878, "project_id": 13, "task_id": 461 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3290786, 47.5994586 ], [ -122.3290815, 47.5993517 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789926, "project_id": 13, "task_id": 68 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328107, 47.5961489 ], [ -122.327915, 47.5961699 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789927, "project_id": 13, "task_id": 68 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327911, 47.5960887 ], [ -122.327901, 47.5961607 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790057, "project_id": 13, "task_id": 386 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3305426, 47.6050168 ], [ -122.3305175, 47.6050247 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790058, "project_id": 13, "task_id": 172 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317055, 47.608279 ], [ -122.3316994, 47.6082949 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790059, "project_id": 13, "task_id": 172 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3316994, 47.6082949 ], [ -122.331675, 47.6083134 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790060, "project_id": 13, "task_id": 172 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331675, 47.6083134 ], [ -122.3316511, 47.6083281 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790061, "project_id": 13, "task_id": 172 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3316511, 47.6083281 ], [ -122.3316012, 47.6083313 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790062, "project_id": 13, "task_id": 172 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3316012, 47.6083313 ], [ -122.3315567, 47.6083157 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790063, "project_id": 13, "task_id": 172 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3315567, 47.6083157 ], [ -122.3315372, 47.6082793 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790064, "project_id": 13, "task_id": 172 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3315372, 47.6082793 ], [ -122.3315627, 47.6082481 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790065, "project_id": 13, "task_id": 172 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3315627, 47.6082481 ], [ -122.3316024, 47.6082345 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790066, "project_id": 13, "task_id": 172 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3316024, 47.6082345 ], [ -122.3316526, 47.6082259 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790148, "project_id": 13, "task_id": 456 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291124, 47.6011355 ], [ -122.3291133, 47.6010837 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790149, "project_id": 13, "task_id": 456 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291776, 47.6011415 ], [ -122.3291366, 47.6010801 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790150, "project_id": 13, "task_id": 456 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291366, 47.6010801 ], [ -122.3291133, 47.6010837 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790151, "project_id": 13, "task_id": 456 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291366, 47.6010801 ], [ -122.329146, 47.6010613 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790152, "project_id": 13, "task_id": 456 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291133, 47.6010837 ], [ -122.329104, 47.6010727 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790153, "project_id": 13, "task_id": 456 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329115, 47.6014642 ], [ -122.3291124, 47.6011355 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790154, "project_id": 13, "task_id": 503 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3294204, 47.6013896 ], [ -122.3291776, 47.6011415 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790155, "project_id": 13, "task_id": 503 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329115, 47.6014642 ], [ -122.3291109, 47.6016138 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790156, "project_id": 13, "task_id": 453 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291188, 47.6007787 ], [ -122.328895, 47.6007895 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790157, "project_id": 13, "task_id": 244 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291279, 47.6007526 ], [ -122.3291254, 47.6001426 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790158, "project_id": 13, "task_id": 453 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291902, 47.6007967 ], [ -122.329148, 47.6007668 ], [ -122.3291279, 47.6007526 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790159, "project_id": 13, "task_id": 453 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329148, 47.6007668 ], [ -122.3291188, 47.6007787 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790160, "project_id": 13, "task_id": 236 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288427, 47.6000936 ], [ -122.3288591, 47.5999792 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790161, "project_id": 13, "task_id": 236 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291166, 47.60011 ], [ -122.3288427, 47.6000936 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790162, "project_id": 13, "task_id": 236 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288637, 47.6001252 ], [ -122.3288296, 47.6001099 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790163, "project_id": 13, "task_id": 236 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288296, 47.6001099 ], [ -122.3288427, 47.6000936 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790164, "project_id": 13, "task_id": 236 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288637, 47.6001252 ], [ -122.3288427, 47.6000936 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790165, "project_id": 13, "task_id": 241 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291364, 47.5999681 ], [ -122.3288978, 47.5999413 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790166, "project_id": 13, "task_id": 241 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291475, 47.5998941 ], [ -122.3291482, 47.599809 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790167, "project_id": 13, "task_id": 241 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288762, 47.5999421 ], [ -122.3288742, 47.5998081 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790168, "project_id": 13, "task_id": 371 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288396, 47.5999677 ], [ -122.3279962, 47.5999683 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790169, "project_id": 13, "task_id": 241 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288762, 47.5999421 ], [ -122.3288759, 47.599962 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790170, "project_id": 13, "task_id": 241 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288759, 47.599962 ], [ -122.3288634, 47.5999671 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790171, "project_id": 13, "task_id": 241 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288634, 47.5999671 ], [ -122.3288396, 47.5999677 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790172, "project_id": 13, "task_id": 241 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288978, 47.5999413 ], [ -122.3288762, 47.5999421 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790173, "project_id": 13, "task_id": 241 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288634, 47.5999671 ], [ -122.3288591, 47.5999792 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790174, "project_id": 13, "task_id": 241 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291565, 47.5995952 ], [ -122.3291482, 47.599809 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790175, "project_id": 13, "task_id": 241 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288694, 47.5994542 ], [ -122.3288742, 47.5998081 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790176, "project_id": 13, "task_id": 465 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291874, 47.5990022 ], [ -122.3291864, 47.5991146 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790177, "project_id": 13, "task_id": 379 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3293068, 47.5989594 ], [ -122.3294212, 47.5990817 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790178, "project_id": 13, "task_id": 380 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3297242, 47.599093 ], [ -122.3294622, 47.5991057 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790179, "project_id": 13, "task_id": 120 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299837, 47.5991052 ], [ -122.3297896, 47.5990959 ], [ -122.3297609, 47.5990955 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790180, "project_id": 13, "task_id": 380 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3297609, 47.5990955 ], [ -122.3297405, 47.5990828 ], [ -122.3297058, 47.5990611 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790181, "project_id": 13, "task_id": 380 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3294212, 47.5990817 ], [ -122.3294434, 47.5991029 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790182, "project_id": 13, "task_id": 380 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3294434, 47.5991029 ], [ -122.3294421, 47.5991168 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790183, "project_id": 13, "task_id": 380 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3294421, 47.5991168 ], [ -122.3294236, 47.5991155 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790184, "project_id": 13, "task_id": 380 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3294622, 47.5991057 ], [ -122.3294434, 47.5991029 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790185, "project_id": 13, "task_id": 380 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3297896, 47.5991149 ], [ -122.3297896, 47.5990959 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790186, "project_id": 13, "task_id": 380 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3297242, 47.599093 ], [ -122.3297405, 47.5990828 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790187, "project_id": 13, "task_id": 380 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3296751, 47.599361 ], [ -122.3296419, 47.5993046 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790188, "project_id": 13, "task_id": 122 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301898, 47.5995494 ], [ -122.3301808, 47.5995284 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790189, "project_id": 13, "task_id": 122 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301047, 47.5995688 ], [ -122.3301367, 47.5995738 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790190, "project_id": 13, "task_id": 122 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301808, 47.5995284 ], [ -122.3301047, 47.5995688 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790191, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343652, 47.6085055 ], [ -122.3342694, 47.6083969 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790192, "project_id": 13, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343865, 47.6085252 ], [ -122.3343652, 47.6085055 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790193, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3342694, 47.6083969 ], [ -122.3342483, 47.6083778 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790194, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3339215, 47.6087205 ], [ -122.3339061, 47.6087251 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790195, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3339061, 47.6087251 ], [ -122.3339064, 47.608737 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790196, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3339305, 47.6087551 ], [ -122.3339064, 47.608737 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790197, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333965, 47.6087025 ], [ -122.3339518, 47.6086911 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790198, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3339545, 47.60878 ], [ -122.3339347, 47.6087829 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790199, "project_id": 13, "task_id": 167 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3339186, 47.6089974 ], [ -122.3337448, 47.6088088 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790200, "project_id": 13, "task_id": 302 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333469, 47.6087356 ], [ -122.3326979, 47.6090413 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790201, "project_id": 13, "task_id": 304 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3326639, 47.6090498 ], [ -122.3324859, 47.6090926 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790202, "project_id": 13, "task_id": 304 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332624, 47.6092658 ], [ -122.3325119, 47.6091519 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790203, "project_id": 13, "task_id": 304 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3328082, 47.6092077 ], [ -122.3326828, 47.6092689 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790204, "project_id": 13, "task_id": 304 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327351, 47.6090598 ], [ -122.3328289, 47.6091683 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790205, "project_id": 13, "task_id": 304 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327351, 47.6090598 ], [ -122.3326979, 47.6090413 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790206, "project_id": 13, "task_id": 304 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3326979, 47.6090413 ], [ -122.3326639, 47.6090498 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790207, "project_id": 13, "task_id": 304 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3326828, 47.6092689 ], [ -122.332648, 47.609294 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790208, "project_id": 13, "task_id": 304 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332648, 47.609294 ], [ -122.332624, 47.6092658 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790209, "project_id": 13, "task_id": 304 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327011, 47.609358 ], [ -122.332648, 47.609294 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790210, "project_id": 13, "task_id": 304 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332648, 47.609294 ], [ -122.3326228, 47.6093058 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790211, "project_id": 13, "task_id": 304 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3328289, 47.6091683 ], [ -122.3328238, 47.6091882 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790212, "project_id": 13, "task_id": 304 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3328238, 47.6091882 ], [ -122.3328082, 47.6092077 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790213, "project_id": 13, "task_id": 415 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3324591, 47.6091017 ], [ -122.332319, 47.6089406 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790214, "project_id": 13, "task_id": 304 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3324859, 47.6090926 ], [ -122.3324591, 47.6091017 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790215, "project_id": 13, "task_id": 216 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336163, 47.6048065 ], [ -122.3354185, 47.6051067 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790216, "project_id": 13, "task_id": 495 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3334595, 47.6018479 ], [ -122.3334682, 47.6018232 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790217, "project_id": 13, "task_id": 495 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3334682, 47.6018232 ], [ -122.333442, 47.6018141 ], [ -122.3334235, 47.6018077 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790218, "project_id": 13, "task_id": 495 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333447, 47.6016641 ], [ -122.3334467, 47.6017889 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790219, "project_id": 13, "task_id": 495 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3335477, 47.6019307 ], [ -122.3334922, 47.6018712 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790220, "project_id": 13, "task_id": 495 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3335157, 47.6019843 ], [ -122.3335477, 47.6019431 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790221, "project_id": 13, "task_id": 495 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3335477, 47.6019307 ], [ -122.3335477, 47.6019431 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790222, "project_id": 13, "task_id": 495 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3335477, 47.6019431 ], [ -122.3335633, 47.6019377 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790223, "project_id": 13, "task_id": 495 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3334922, 47.6018712 ], [ -122.3334595, 47.6018479 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790224, "project_id": 13, "task_id": 495 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3334467, 47.6017889 ], [ -122.333442, 47.6018141 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790225, "project_id": 13, "task_id": 495 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333447, 47.6016641 ], [ -122.3334445, 47.6016478 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790226, "project_id": 13, "task_id": 103 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3324112, 47.5992735 ], [ -122.3318228, 47.5992723 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790227, "project_id": 13, "task_id": 103 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3324335, 47.5991343 ], [ -122.3318228, 47.5991396 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790228, "project_id": 13, "task_id": 121 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3312568, 47.5992755 ], [ -122.3306124, 47.5992717 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790229, "project_id": 13, "task_id": 71 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275895, 47.5974397 ], [ -122.3275892, 47.5974253 ], [ -122.327577, 47.596699 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790230, "project_id": 13, "task_id": 86 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249449, 47.5957523 ], [ -122.3249662, 47.5959293 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790231, "project_id": 13, "task_id": 86 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251881, 47.5957603 ], [ -122.3251806, 47.5959323 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790232, "project_id": 13, "task_id": 86 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251545, 47.5959468 ], [ -122.3250092, 47.5959552 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790252, "project_id": 13, "task_id": 314 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265058, 47.5959549 ], [ -122.326498, 47.5964609 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790365, "project_id": 13, "task_id": 31 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360262, 47.5982722 ], [ -122.3360196, 47.5982504 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790366, "project_id": 13, "task_id": 31 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360196, 47.5982504 ], [ -122.3360169, 47.5981492 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790367, "project_id": 13, "task_id": 31 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360169, 47.5981492 ], [ -122.3360181, 47.5981326 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790368, "project_id": 13, "task_id": 31 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360181, 47.5981326 ], [ -122.3359948, 47.5980917 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790369, "project_id": 13, "task_id": 31 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360181, 47.5981326 ], [ -122.3361662, 47.598129 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790370, "project_id": 13, "task_id": 31 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3361662, 47.598129 ], [ -122.3361915, 47.5981104 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790371, "project_id": 13, "task_id": 31 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3361915, 47.5981104 ], [ -122.3361897, 47.5978273 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790372, "project_id": 13, "task_id": 31 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3359473, 47.5980738 ], [ -122.3357571, 47.5980763 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790373, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3211484, 47.601505 ], [ -122.3209394, 47.6015572 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790374, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209394, 47.6015572 ], [ -122.3208451, 47.6015806 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790375, "project_id": 13, "task_id": 276 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3212614, 47.6013163 ], [ -122.3212648, 47.6013995 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790376, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3212648, 47.6013995 ], [ -122.3211484, 47.601505 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790377, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220167, 47.6014602 ], [ -122.3218192, 47.6014628 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790378, "project_id": 13, "task_id": 276 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218192, 47.6014628 ], [ -122.3216389, 47.6013743 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790379, "project_id": 13, "task_id": 276 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3216389, 47.6013743 ], [ -122.3215384, 47.6012747 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790380, "project_id": 13, "task_id": 276 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218192, 47.6014628 ], [ -122.3216001, 47.6014145 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790381, "project_id": 13, "task_id": 191 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3216001, 47.6014145 ], [ -122.3214857, 47.6013575 ], [ -122.3214045, 47.6012763 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790382, "project_id": 13, "task_id": 276 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3211919, 47.6017853 ], [ -122.3216106, 47.6022765 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790383, "project_id": 13, "task_id": 276 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321687, 47.6022982 ], [ -122.321657, 47.6022656 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790384, "project_id": 13, "task_id": 276 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321657, 47.6022656 ], [ -122.3216106, 47.6022765 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790385, "project_id": 13, "task_id": 81 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251748, 47.5965967 ], [ -122.3249891, 47.5965945 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790386, "project_id": 13, "task_id": 81 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325205, 47.5966175 ], [ -122.3251708, 47.5967563 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790387, "project_id": 13, "task_id": 81 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251708, 47.5967563 ], [ -122.3249869, 47.5967571 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790388, "project_id": 13, "task_id": 81 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249588, 47.5966157 ], [ -122.3249869, 47.5967571 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790389, "project_id": 13, "task_id": 81 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251935, 47.5965912 ], [ -122.3251748, 47.5965967 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790390, "project_id": 13, "task_id": 81 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252197, 47.5966025 ], [ -122.325205, 47.5966175 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790391, "project_id": 13, "task_id": 81 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249702, 47.5965929 ], [ -122.3249891, 47.5965945 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790392, "project_id": 13, "task_id": 81 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249702, 47.5965929 ], [ -122.3249544, 47.5966076 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790393, "project_id": 13, "task_id": 81 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249544, 47.5966076 ], [ -122.3247391, 47.5966077 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790394, "project_id": 13, "task_id": 81 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249588, 47.5966157 ], [ -122.3249544, 47.5966076 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790395, "project_id": 13, "task_id": 81 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251879, 47.5974299 ], [ -122.3251878, 47.5974082 ], [ -122.3251866, 47.5967549 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790396, "project_id": 13, "task_id": 81 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324965, 47.5967553 ], [ -122.3247373, 47.5967497 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790397, "project_id": 13, "task_id": 81 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251866, 47.5967549 ], [ -122.3251708, 47.5967563 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790398, "project_id": 13, "task_id": 81 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249869, 47.5967571 ], [ -122.324965, 47.5967553 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790419, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193283, 47.6027463 ], [ -122.3193018, 47.602758 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790420, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319526, 47.6031162 ], [ -122.3195439, 47.6031249 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790421, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195946, 47.6031126 ], [ -122.319594, 47.6031241 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790422, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319594, 47.6031241 ], [ -122.3195439, 47.6031249 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790423, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3210531, 47.6033422 ], [ -122.3209018, 47.6034021 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790454, "project_id": 13, "task_id": 87 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3247373, 47.5967497 ], [ -122.3240907, 47.5967473 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790455, "project_id": 13, "task_id": 87 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3247391, 47.5966077 ], [ -122.3240907, 47.5966045 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790456, "project_id": 13, "task_id": 87 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240907, 47.5966045 ], [ -122.3239135, 47.5966006 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790457, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236185, 47.596605 ], [ -122.3232505, 47.5966048 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790458, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236589, 47.596747 ], [ -122.3236583, 47.5968659 ], [ -122.3236626, 47.5974089 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790459, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236583, 47.5968659 ], [ -122.3236243, 47.5968958 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790460, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236243, 47.5968958 ], [ -122.3235666, 47.596931 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790461, "project_id": 13, "task_id": 87 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240907, 47.5967473 ], [ -122.3239281, 47.5967515 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790462, "project_id": 13, "task_id": 319 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235666, 47.596931 ], [ -122.3234891, 47.596959 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790463, "project_id": 13, "task_id": 320 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3234891, 47.596959 ], [ -122.3233642, 47.5969577 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790464, "project_id": 13, "task_id": 320 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3233642, 47.5969577 ], [ -122.3233689, 47.5967464 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790465, "project_id": 13, "task_id": 320 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3234891, 47.596959 ], [ -122.3235076, 47.597008 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790466, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240806, 47.5975898 ], [ -122.323937, 47.5975938 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790467, "project_id": 13, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249328, 47.5975946 ], [ -122.3240806, 47.5975898 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790468, "project_id": 13, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249366, 47.5974428 ], [ -122.3249219, 47.5974428 ], [ -122.3240854, 47.5974443 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790469, "project_id": 13, "task_id": 423 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.32645, 47.5966058 ], [ -122.3263023, 47.5965986 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790470, "project_id": 13, "task_id": 423 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265039, 47.5966089 ], [ -122.32645, 47.5966058 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790471, "project_id": 13, "task_id": 423 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3263023, 47.5965986 ], [ -122.3262701, 47.5965944 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790485, "project_id": 13, "task_id": 68 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327915, 47.5961699 ], [ -122.327901, 47.5961607 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790486, "project_id": 13, "task_id": 180 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277789, 47.5966806 ], [ -122.3276112, 47.5966784 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790487, "project_id": 13, "task_id": 180 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3276112, 47.5966784 ], [ -122.3275775, 47.5966752 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790488, "project_id": 13, "task_id": 68 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3279479, 47.5960628 ], [ -122.3279025, 47.5960791 ], [ -122.3278609, 47.5960943 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790489, "project_id": 13, "task_id": 180 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278609, 47.5960943 ], [ -122.3278645, 47.5960377 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790490, "project_id": 13, "task_id": 68 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327915, 47.5961699 ], [ -122.3278716, 47.5961912 ], [ -122.3278308, 47.5962226 ], [ -122.3278, 47.5963015 ], [ -122.3278, 47.5964504 ], [ -122.327798, 47.5966809 ], [ -122.3278048, 47.5974423 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790491, "project_id": 13, "task_id": 180 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327778, 47.5966806 ], [ -122.327798, 47.5966809 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790492, "project_id": 13, "task_id": 68 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3283857, 47.5966878 ], [ -122.327798, 47.5966809 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790499, "project_id": 13, "task_id": 68 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3279479, 47.5960628 ], [ -122.3279556, 47.5960578 ], [ -122.3279268, 47.5960445 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790500, "project_id": 13, "task_id": 68 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327911, 47.5960887 ], [ -122.3279025, 47.5960791 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790501, "project_id": 13, "task_id": 68 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3279189, 47.5960356 ], [ -122.3279268, 47.5960445 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790502, "project_id": 13, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249667, 47.5974272 ], [ -122.3249366, 47.5974428 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790503, "project_id": 13, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249876, 47.5974062 ], [ -122.3249666, 47.5974055 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790504, "project_id": 13, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249227, 47.5974521 ], [ -122.3249219, 47.5974428 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790505, "project_id": 13, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252613, 47.5974433 ], [ -122.3252314, 47.5974453 ], [ -122.3251879, 47.5974299 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790506, "project_id": 13, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251878, 47.5974082 ], [ -122.3251681, 47.5974075 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790507, "project_id": 13, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252613, 47.5974433 ], [ -122.3252672, 47.5974592 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790508, "project_id": 13, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249763, 47.5976123 ], [ -122.3249328, 47.5975946 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790509, "project_id": 13, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3250245, 47.5976059 ], [ -122.3249763, 47.5976123 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790510, "project_id": 13, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249652, 47.5975657 ], [ -122.3249328, 47.5975946 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790511, "project_id": 13, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251771, 47.5982714 ], [ -122.325174, 47.5976088 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790512, "project_id": 13, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3253766, 47.5975927 ], [ -122.3252043, 47.5975862 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790513, "project_id": 13, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252043, 47.5975862 ], [ -122.325174, 47.5976088 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790514, "project_id": 13, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251837, 47.5975589 ], [ -122.3252043, 47.5975862 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790515, "project_id": 13, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325174, 47.5976088 ], [ -122.3251215, 47.5976086 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790516, "project_id": 13, "task_id": 80 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262513, 47.5975922 ], [ -122.3253766, 47.5975927 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790517, "project_id": 13, "task_id": 71 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275515, 47.5975986 ], [ -122.326507, 47.597596 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790518, "project_id": 13, "task_id": 71 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275273, 47.5974535 ], [ -122.3265269, 47.5974505 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790519, "project_id": 13, "task_id": 183 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326497, 47.5982751 ], [ -122.3264874, 47.5976091 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790520, "project_id": 13, "task_id": 183 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262681, 47.5982655 ], [ -122.3262732, 47.597609 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790521, "project_id": 13, "task_id": 183 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326507, 47.597596 ], [ -122.3264874, 47.5976091 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790522, "project_id": 13, "task_id": 183 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265037, 47.597581 ], [ -122.326507, 47.597596 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790523, "project_id": 13, "task_id": 183 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264874, 47.5976091 ], [ -122.3264658, 47.5975993 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790524, "project_id": 13, "task_id": 183 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262732, 47.597609 ], [ -122.3262513, 47.5975922 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790525, "project_id": 13, "task_id": 183 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262945, 47.5975971 ], [ -122.3262732, 47.597609 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790526, "project_id": 13, "task_id": 183 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262693, 47.5975813 ], [ -122.3262513, 47.5975922 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790561, "project_id": 13, "task_id": 71 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275895, 47.5974397 ], [ -122.3275744, 47.5974529 ], [ -122.3275691, 47.597453 ], [ -122.3275273, 47.5974535 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790562, "project_id": 13, "task_id": 71 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275722, 47.5974702 ], [ -122.3275691, 47.597453 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790563, "project_id": 13, "task_id": 71 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3276006, 47.5974251 ], [ -122.3275892, 47.5974253 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790564, "project_id": 13, "task_id": 35 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275199, 47.5982909 ], [ -122.326706, 47.5982873 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790565, "project_id": 13, "task_id": 378 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327815, 47.5983022 ], [ -122.3278045, 47.5984372 ], [ -122.3278048, 47.5990529 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790566, "project_id": 13, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277728, 47.5984387 ], [ -122.3275968, 47.5984528 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790567, "project_id": 13, "task_id": 35 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275735, 47.5990712 ], [ -122.3275747, 47.598455 ], [ -122.3275742, 47.5984454 ], [ -122.327553, 47.5984263 ], [ -122.3275172, 47.5984186 ], [ -122.326704, 47.5984259 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790568, "project_id": 13, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277728, 47.5984387 ], [ -122.3278045, 47.5984372 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790569, "project_id": 13, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275968, 47.5984528 ], [ -122.3275747, 47.598455 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790570, "project_id": 13, "task_id": 255 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262384, 47.5984332 ], [ -122.3251928, 47.5984413 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790582, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238648, 47.5982426 ], [ -122.3235946, 47.5982914 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790583, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238648, 47.5982426 ], [ -122.3239238, 47.5984223 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790584, "project_id": 13, "task_id": 254 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262618, 47.5984452 ], [ -122.3262547, 47.598435 ], [ -122.3262384, 47.5984332 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790585, "project_id": 13, "task_id": 254 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262837, 47.5984354 ], [ -122.3262618, 47.5984452 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790586, "project_id": 13, "task_id": 254 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262579, 47.59842 ], [ -122.3262384, 47.5984332 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790587, "project_id": 13, "task_id": 254 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262681, 47.5982655 ], [ -122.3262621, 47.5982791 ], [ -122.3262411, 47.5982824 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790588, "project_id": 13, "task_id": 254 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262922, 47.5982754 ], [ -122.3262681, 47.5982655 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790589, "project_id": 13, "task_id": 254 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262544, 47.5982972 ], [ -122.3262411, 47.5982824 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790590, "project_id": 13, "task_id": 254 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326706, 47.5982873 ], [ -122.326528, 47.5982866 ], [ -122.326497, 47.5982751 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790591, "project_id": 13, "task_id": 254 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326528, 47.5982866 ], [ -122.3264962, 47.5982953 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790592, "project_id": 13, "task_id": 254 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326497, 47.5982751 ], [ -122.3264726, 47.5982743 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790593, "project_id": 13, "task_id": 254 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326704, 47.5984259 ], [ -122.3265014, 47.5984272 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790594, "project_id": 13, "task_id": 254 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265014, 47.5984272 ], [ -122.3264823, 47.5984335 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790595, "project_id": 13, "task_id": 254 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265014, 47.5984272 ], [ -122.326502, 47.5984202 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790596, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264626, 47.5993073 ], [ -122.3262957, 47.5993062 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790597, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326227, 47.5992778 ], [ -122.326272, 47.5991124 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790598, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264482, 47.5990862 ], [ -122.326309, 47.5990806 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790599, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265399, 47.5991832 ], [ -122.3265445, 47.5991179 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790600, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275215, 47.5990968 ], [ -122.3265662, 47.5990944 ], [ -122.326539, 47.5990932 ], [ -122.3265166, 47.5990922 ], [ -122.3264888, 47.5990743 ], [ -122.3264774, 47.5990349 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790601, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326539, 47.5990932 ], [ -122.3265445, 47.5991179 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790602, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275534, 47.5993079 ], [ -122.3275439, 47.5993079 ], [ -122.327029, 47.5993041 ], [ -122.3265477, 47.5993016 ], [ -122.3265338, 47.5993014 ], [ -122.3264941, 47.5993094 ], [ -122.3264702, 47.5993328 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790603, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265477, 47.5993016 ], [ -122.326545, 47.5992827 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790604, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262597, 47.5996038 ], [ -122.3262684, 47.5993349 ], [ -122.3262598, 47.5993126 ], [ -122.3262347, 47.5993027 ], [ -122.326199, 47.5993018 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790605, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262957, 47.5993062 ], [ -122.3262598, 47.5993126 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790606, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262347, 47.5993027 ], [ -122.326227, 47.5992778 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790639, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326545, 47.5992827 ], [ -122.32654, 47.5992131 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790640, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265399, 47.5991832 ], [ -122.3265399, 47.5991986 ], [ -122.32654, 47.5992131 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790641, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275397, 47.5991999 ], [ -122.3265399, 47.5991986 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790647, "project_id": 13, "task_id": 252 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327029, 47.5993041 ], [ -122.3270287, 47.5998975 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790648, "project_id": 13, "task_id": 376 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275397, 47.5992158 ], [ -122.3275397, 47.5991999 ], [ -122.3275404, 47.5991863 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790649, "project_id": 13, "task_id": 374 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275404, 47.5991863 ], [ -122.3275721, 47.5991047 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790650, "project_id": 13, "task_id": 247 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275534, 47.5993079 ], [ -122.3275706, 47.5993205 ], [ -122.3275607, 47.599942 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790651, "project_id": 13, "task_id": 376 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275439, 47.5993079 ], [ -122.3275588, 47.5992883 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790652, "project_id": 13, "task_id": 377 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278616, 47.5992906 ], [ -122.3278611, 47.5993032 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790653, "project_id": 13, "task_id": 377 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278967, 47.599128 ], [ -122.3278965, 47.5991082 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790654, "project_id": 13, "task_id": 374 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275735, 47.5990712 ], [ -122.3275742, 47.5990785 ], [ -122.3275542, 47.5990896 ], [ -122.3275411, 47.5990968 ], [ -122.3275215, 47.5990968 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790655, "project_id": 13, "task_id": 374 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277949, 47.5998353 ], [ -122.3278132, 47.5993098 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790656, "project_id": 13, "task_id": 374 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278456, 47.5993031 ], [ -122.3278334, 47.5993021 ], [ -122.3278132, 47.5993098 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790657, "project_id": 13, "task_id": 374 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278038, 47.5993078 ], [ -122.3278132, 47.5993098 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790658, "project_id": 13, "task_id": 247 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278516, 47.5999865 ], [ -122.3278279, 47.6001027 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790659, "project_id": 13, "task_id": 247 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277794, 47.6001195 ], [ -122.3275709, 47.6001177 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790660, "project_id": 13, "task_id": 247 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275278, 47.6000843 ], [ -122.3275257, 47.5999884 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790661, "project_id": 13, "task_id": 247 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327808, 47.5999455 ], [ -122.3275763, 47.5999575 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790662, "project_id": 13, "task_id": 247 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278329, 47.600114 ], [ -122.327828, 47.600114 ], [ -122.3278085, 47.6001143 ], [ -122.3277944, 47.6001245 ], [ -122.327791, 47.6001777 ], [ -122.3278011, 47.6007824 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790663, "project_id": 13, "task_id": 247 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327828, 47.600114 ], [ -122.3278279, 47.6001027 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790664, "project_id": 13, "task_id": 247 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277944, 47.6001245 ], [ -122.3277794, 47.6001195 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790665, "project_id": 13, "task_id": 247 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327563, 47.6007867 ], [ -122.327563, 47.6001321 ], [ -122.3275488, 47.600118 ], [ -122.3275381, 47.6001073 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790666, "project_id": 13, "task_id": 247 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275278, 47.6000843 ], [ -122.3275266, 47.6001074 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790667, "project_id": 13, "task_id": 247 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275709, 47.6001177 ], [ -122.3275488, 47.600118 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790668, "project_id": 13, "task_id": 247 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275607, 47.599942 ], [ -122.3275587, 47.599955 ], [ -122.3275568, 47.5999673 ], [ -122.3275147, 47.5999681 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790669, "project_id": 13, "task_id": 247 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275147, 47.5999681 ], [ -122.3275257, 47.5999884 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790670, "project_id": 13, "task_id": 247 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275763, 47.5999575 ], [ -122.3275587, 47.599955 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790671, "project_id": 13, "task_id": 247 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3279962, 47.5999683 ], [ -122.3279037, 47.59997 ], [ -122.3278702, 47.5999703 ], [ -122.327859, 47.599967 ], [ -122.3278358, 47.5999601 ], [ -122.3278167, 47.599941 ], [ -122.3278035, 47.5999277 ], [ -122.3277949, 47.5998353 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790672, "project_id": 13, "task_id": 247 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278516, 47.5999865 ], [ -122.327859, 47.599967 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790673, "project_id": 13, "task_id": 247 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327808, 47.5999455 ], [ -122.3278167, 47.599941 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790674, "project_id": 13, "task_id": 15 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238806, 47.5999608 ], [ -122.3236572, 47.5999591 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790675, "project_id": 13, "task_id": 457 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277899, 47.6009792 ], [ -122.3277847, 47.6012985 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790676, "project_id": 13, "task_id": 445 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275531, 47.6010011 ], [ -122.3275491, 47.6012933 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790677, "project_id": 13, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317261, 47.5978168 ], [ -122.3317327, 47.5975348 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790678, "project_id": 13, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3323238, 47.597538 ], [ -122.3317327, 47.5975348 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790679, "project_id": 13, "task_id": 34 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331491, 47.5978162 ], [ -122.3314787, 47.5975273 ], [ -122.3304538, 47.5975181 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790680, "project_id": 13, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3328295, 47.5967403 ], [ -122.3325975, 47.5967388 ], [ -122.3324172, 47.5967376 ], [ -122.3322434, 47.5967364 ], [ -122.3317013, 47.5967328 ], [ -122.3314998, 47.5967315 ], [ -122.3304317, 47.5967244 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790681, "project_id": 13, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3325975, 47.5967388 ], [ -122.3325926, 47.5966734 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790682, "project_id": 13, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3324172, 47.5967376 ], [ -122.3324118, 47.5966771 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790683, "project_id": 13, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3322434, 47.5967364 ], [ -122.3322732, 47.5966718 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790684, "project_id": 13, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317013, 47.5967328 ], [ -122.3317123, 47.5966437 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790685, "project_id": 13, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314998, 47.5967315 ], [ -122.3315, 47.5966391 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790686, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3221707, 47.6025984 ], [ -122.3220802, 47.602631 ], [ -122.3219729, 47.6025144 ], [ -122.3219625, 47.6025031 ], [ -122.3218221, 47.6024702 ], [ -122.3219357, 47.6024137 ], [ -122.321927, 47.6024008 ], [ -122.3217507, 47.602397 ], [ -122.3217327, 47.6024001 ], [ -122.3218033, 47.6024775 ], [ -122.3218504, 47.6025291 ], [ -122.3218864, 47.602536 ], [ -122.3218937, 47.6025435 ], [ -122.3219337, 47.6025846 ], [ -122.3219633, 47.60262 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790687, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219729, 47.6025144 ], [ -122.3218937, 47.6025435 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790688, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218221, 47.6024702 ], [ -122.3218033, 47.6024775 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790689, "project_id": 13, "task_id": 276 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3217327, 47.6024001 ], [ -122.321687, 47.6022982 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952344, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3207191, 47.6055466 ], [ -122.3207191, 47.6053731 ], [ -122.3207191, 47.6053615 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952345, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206987, 47.6053716 ], [ -122.3206578, 47.6053716 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952346, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3207191, 47.6053731 ], [ -122.3206987, 47.6053716 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952347, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206578, 47.6053716 ], [ -122.3206179, 47.6053707 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952525, "project_id": 13, "task_id": 140 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220401, 47.6041074 ], [ -122.3219142, 47.6039725 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952526, "project_id": 13, "task_id": 140 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220401, 47.6041074 ], [ -122.3220464, 47.6041164 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952527, "project_id": 13, "task_id": 140 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219142, 47.6039725 ], [ -122.3219052, 47.603963 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952528, "project_id": 13, "task_id": 140 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219052, 47.603963 ], [ -122.3218631, 47.6039167 ], [ -122.321855, 47.6039077 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952529, "project_id": 13, "task_id": 398 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235196, 47.6041176 ], [ -122.3234124, 47.6041513 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952530, "project_id": 13, "task_id": 398 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323549, 47.6041082 ], [ -122.3235196, 47.6041176 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952531, "project_id": 13, "task_id": 398 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3234124, 47.6041513 ], [ -122.323393, 47.6041612 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952689, "project_id": 13, "task_id": 37 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3266793, 47.6068284 ], [ -122.3262322, 47.607007 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952690, "project_id": 13, "task_id": 37 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3266223, 47.6066659 ], [ -122.3261332, 47.6068812 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952691, "project_id": 13, "task_id": 471 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275422, 47.6084679 ], [ -122.3275441, 47.6084702 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952692, "project_id": 13, "task_id": 473 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327478, 47.6082829 ], [ -122.3274328, 47.6083004 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952693, "project_id": 13, "task_id": 473 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3274328, 47.6083004 ], [ -122.3274208, 47.6083064 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952694, "project_id": 13, "task_id": 473 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3274328, 47.6083004 ], [ -122.3273915, 47.6082953 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952695, "project_id": 13, "task_id": 473 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3273855, 47.6085361 ], [ -122.327359, 47.6085464 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952696, "project_id": 13, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3267435, 47.6095746 ], [ -122.3266829, 47.6096024 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952697, "project_id": 13, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3271668, 47.6094072 ], [ -122.3269562, 47.6094931 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952698, "project_id": 13, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327063, 47.6095819 ], [ -122.3270883, 47.6095924 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952699, "project_id": 13, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3272215, 47.6095467 ], [ -122.3270883, 47.6095924 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952700, "project_id": 13, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3270883, 47.6095924 ], [ -122.3270789, 47.6096046 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952710, "project_id": 13, "task_id": 472 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277629, 47.6081691 ], [ -122.327478, 47.6082829 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952711, "project_id": 13, "task_id": 471 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278754, 47.6088127 ], [ -122.3275441, 47.6084702 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952712, "project_id": 13, "task_id": 475 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277095, 47.6091716 ], [ -122.3271668, 47.6094072 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952713, "project_id": 13, "task_id": 475 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277743, 47.6093372 ], [ -122.3272215, 47.6095467 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952714, "project_id": 13, "task_id": 476 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3281565, 47.6079945 ], [ -122.3277629, 47.6081691 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952745, "project_id": 13, "task_id": 414 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3319251, 47.6085601 ], [ -122.3318175, 47.6084801 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952746, "project_id": 13, "task_id": 414 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3319985, 47.6083391 ], [ -122.3317762, 47.6083506 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952747, "project_id": 13, "task_id": 414 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3318018, 47.6084536 ], [ -122.331771, 47.6083691 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952748, "project_id": 13, "task_id": 414 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3320939, 47.6086915 ], [ -122.3320159, 47.6085936 ], [ -122.3319463, 47.6085816 ], [ -122.331802, 47.6086451 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952749, "project_id": 13, "task_id": 414 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3320531, 47.6083312 ], [ -122.3320237, 47.6083181 ], [ -122.3320099, 47.6083119 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952750, "project_id": 13, "task_id": 414 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3318373, 47.6084637 ], [ -122.3318124, 47.6084737 ], [ -122.3317428, 47.6085016 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952751, "project_id": 13, "task_id": 414 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3318373, 47.6084637 ], [ -122.3318063, 47.6084659 ], [ -122.3317287, 47.6084713 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952752, "project_id": 13, "task_id": 172 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317414, 47.6083152 ], [ -122.3317602, 47.6083553 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952753, "project_id": 13, "task_id": 414 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3321836, 47.6084532 ], [ -122.3321906, 47.6084684 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952754, "project_id": 13, "task_id": 414 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3321573, 47.6084903 ], [ -122.3321783, 47.6084806 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952755, "project_id": 13, "task_id": 414 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3320354, 47.60857 ], [ -122.3320159, 47.6085936 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952756, "project_id": 13, "task_id": 414 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3319251, 47.6085601 ], [ -122.3319463, 47.6085816 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952757, "project_id": 13, "task_id": 414 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3320879, 47.608342 ], [ -122.3320692, 47.6083251 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952758, "project_id": 13, "task_id": 414 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3319985, 47.6083391 ], [ -122.3320237, 47.6083181 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952759, "project_id": 13, "task_id": 414 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317762, 47.6083506 ], [ -122.3317602, 47.6083553 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952760, "project_id": 13, "task_id": 414 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331771, 47.6083691 ], [ -122.3317602, 47.6083553 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952761, "project_id": 13, "task_id": 414 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3318175, 47.6084801 ], [ -122.3318124, 47.6084737 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952762, "project_id": 13, "task_id": 414 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3318018, 47.6084536 ], [ -122.3318063, 47.6084659 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952763, "project_id": 13, "task_id": 414 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332319, 47.6089406 ], [ -122.3320939, 47.6086915 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952764, "project_id": 13, "task_id": 474 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328164, 47.6091799 ], [ -122.3280142, 47.6092252 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952765, "project_id": 13, "task_id": 474 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3281623, 47.6091379 ], [ -122.327994, 47.6093322 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952766, "project_id": 13, "task_id": 474 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3279617, 47.609209 ], [ -122.3278957, 47.609126 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952767, "project_id": 13, "task_id": 474 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327994, 47.6093322 ], [ -122.3278957, 47.609126 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952768, "project_id": 13, "task_id": 471 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278754, 47.6088127 ], [ -122.3280507, 47.6090219 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952769, "project_id": 13, "task_id": 474 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3286104, 47.6089851 ], [ -122.3282114, 47.6091584 ], [ -122.3282076, 47.6091803 ], [ -122.3284195, 47.6094093 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952770, "project_id": 13, "task_id": 475 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327954, 47.6092532 ], [ -122.3277743, 47.6093372 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952771, "project_id": 13, "task_id": 474 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3282709, 47.609548 ], [ -122.3280221, 47.6092583 ], [ -122.3280157, 47.6092578 ], [ -122.327954, 47.6092532 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952772, "project_id": 13, "task_id": 474 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3279617, 47.609209 ], [ -122.327954, 47.6092532 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952773, "project_id": 13, "task_id": 474 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3280142, 47.6092252 ], [ -122.3280157, 47.6092578 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952774, "project_id": 13, "task_id": 474 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3282076, 47.6091803 ], [ -122.328164, 47.6091799 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952775, "project_id": 13, "task_id": 474 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3282114, 47.6091584 ], [ -122.3281623, 47.6091379 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952776, "project_id": 13, "task_id": 475 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278501, 47.6090873 ], [ -122.3278663, 47.6091063 ], [ -122.3278627, 47.60912 ], [ -122.3278605, 47.6091281 ], [ -122.3277095, 47.6091716 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952777, "project_id": 13, "task_id": 474 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3278957, 47.609126 ], [ -122.3278627, 47.60912 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952778, "project_id": 13, "task_id": 474 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3285575, 47.6088573 ], [ -122.328118, 47.6090158 ], [ -122.3280817, 47.6090191 ], [ -122.3280507, 47.6090219 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952779, "project_id": 13, "task_id": 474 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3280817, 47.6090191 ], [ -122.327994, 47.6093322 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952780, "project_id": 13, "task_id": 308 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3300412, 47.6095355 ], [ -122.3299427, 47.6094085 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952781, "project_id": 13, "task_id": 308 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3296187, 47.6093439 ], [ -122.3294007, 47.609086 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952787, "project_id": 13, "task_id": 169 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3286348, 47.6080061 ], [ -122.328479, 47.6080743 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952788, "project_id": 13, "task_id": 169 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3286348, 47.6080061 ], [ -122.3286665, 47.6079998 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952789, "project_id": 13, "task_id": 169 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3282808, 47.6079438 ], [ -122.328169, 47.6079877 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952790, "project_id": 13, "task_id": 169 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3283135, 47.6079117 ], [ -122.3280863, 47.6076617 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952791, "project_id": 13, "task_id": 169 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3282978, 47.6079227 ], [ -122.3282808, 47.6079438 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952852, "project_id": 13, "task_id": 414 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317428, 47.6085016 ], [ -122.3310502, 47.6087836 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952857, "project_id": 13, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3305229, 47.6089975 ], [ -122.3305599, 47.6091425 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952858, "project_id": 13, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3307669, 47.6089174 ], [ -122.3305525, 47.6089446 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952859, "project_id": 13, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3307551, 47.6090788 ], [ -122.3305599, 47.6091425 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952860, "project_id": 13, "task_id": 312 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3305301, 47.6089472 ], [ -122.3305154, 47.6089849 ], [ -122.3304621, 47.6090213 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952861, "project_id": 13, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3305525, 47.6089446 ], [ -122.3305301, 47.6089472 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952862, "project_id": 13, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3305229, 47.6089975 ], [ -122.3305154, 47.6089849 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952863, "project_id": 13, "task_id": 13 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3306408, 47.6093167 ], [ -122.330576, 47.6091611 ], [ -122.3305618, 47.6091623 ], [ -122.3305185, 47.6091662 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952864, "project_id": 13, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3305599, 47.6091425 ], [ -122.3305618, 47.6091623 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952865, "project_id": 13, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33078, 47.6090665 ], [ -122.3307551, 47.6090788 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952866, "project_id": 13, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3310502, 47.6087836 ], [ -122.3308353, 47.608876 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952867, "project_id": 13, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3307669, 47.6089174 ], [ -122.3307804, 47.6089095 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952868, "project_id": 13, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3308353, 47.608876 ], [ -122.3307804, 47.6089095 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952877, "project_id": 13, "task_id": 169 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3280863, 47.6076617 ], [ -122.3278119, 47.6073487 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952885, "project_id": 13, "task_id": 481 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3311932, 47.607754 ], [ -122.3312936, 47.6078333 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952886, "project_id": 13, "task_id": 481 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3312936, 47.6078333 ], [ -122.3313075, 47.6078509 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952887, "project_id": 13, "task_id": 417 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3313163, 47.6078474 ], [ -122.3313075, 47.6078509 ], [ -122.330765, 47.6080756 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952888, "project_id": 13, "task_id": 481 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3311848, 47.6077439 ], [ -122.3307113, 47.607939 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952889, "project_id": 13, "task_id": 481 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3311932, 47.607754 ], [ -122.3311848, 47.6077439 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952937, "project_id": 13, "task_id": 417 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303269, 47.6082588 ], [ -122.330223, 47.6082936 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952938, "project_id": 13, "task_id": 417 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3302495, 47.6081292 ], [ -122.3301206, 47.6081653 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952939, "project_id": 13, "task_id": 417 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3300723, 47.6081585 ], [ -122.3300643, 47.6081838 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952940, "project_id": 13, "task_id": 417 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330765, 47.6080756 ], [ -122.3303506, 47.6082452 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952941, "project_id": 13, "task_id": 417 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3307113, 47.607939 ], [ -122.3302879, 47.6081198 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952942, "project_id": 13, "task_id": 417 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3302089, 47.6083176 ], [ -122.3301769, 47.6083049 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952943, "project_id": 13, "task_id": 417 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303506, 47.6082452 ], [ -122.3303269, 47.6082588 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952944, "project_id": 13, "task_id": 417 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330223, 47.6082936 ], [ -122.3302089, 47.6083176 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952945, "project_id": 13, "task_id": 417 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301612, 47.6082827 ], [ -122.3301769, 47.6083049 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952946, "project_id": 13, "task_id": 417 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3302879, 47.6081198 ], [ -122.3302495, 47.6081292 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952947, "project_id": 13, "task_id": 417 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301206, 47.6081653 ], [ -122.3300723, 47.6081585 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952948, "project_id": 13, "task_id": 417 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301013, 47.6082043 ], [ -122.3300643, 47.6081838 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952951, "project_id": 13, "task_id": 308 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3294007, 47.609086 ], [ -122.3291355, 47.608765 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952952, "project_id": 13, "task_id": 307 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3290863, 47.6087529 ], [ -122.3286104, 47.6089851 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952953, "project_id": 13, "task_id": 307 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3289661, 47.6086566 ], [ -122.3285575, 47.6088573 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952955, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275795, 47.6045171 ], [ -122.3271552, 47.6046747 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952956, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3277542, 47.6053465 ], [ -122.3275672, 47.6054304 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952957, "project_id": 13, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3283557, 47.6049469 ], [ -122.3278112, 47.6051693 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952958, "project_id": 13, "task_id": 12 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3288594, 47.6068587 ], [ -122.3287896, 47.6067853 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952961, "project_id": 13, "task_id": 310 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3305553, 47.6069834 ], [ -122.3295992, 47.6073808 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952962, "project_id": 13, "task_id": 310 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3306759, 47.6071372 ], [ -122.3297493, 47.6075255 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952963, "project_id": 13, "task_id": 310 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3294144, 47.6074293 ], [ -122.3293971, 47.6074559 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952964, "project_id": 13, "task_id": 310 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3295905, 47.6073854 ], [ -122.3294497, 47.607443 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952965, "project_id": 13, "task_id": 310 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3297344, 47.6075327 ], [ -122.3296177, 47.6076057 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952966, "project_id": 13, "task_id": 310 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3295992, 47.6073808 ], [ -122.3295905, 47.6073854 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952967, "project_id": 13, "task_id": 310 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3294497, 47.607443 ], [ -122.3294144, 47.6074293 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952968, "project_id": 13, "task_id": 310 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3294196, 47.6074753 ], [ -122.3293971, 47.6074559 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952969, "project_id": 13, "task_id": 310 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3297493, 47.6075255 ], [ -122.3297344, 47.6075327 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952970, "project_id": 13, "task_id": 310 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.329531, 47.6075987 ], [ -122.3295391, 47.6076077 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952971, "project_id": 13, "task_id": 310 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3296177, 47.6076057 ], [ -122.3296018, 47.6076149 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952972, "project_id": 13, "task_id": 310 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3296018, 47.6076149 ], [ -122.3295391, 47.6076077 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952990, "project_id": 13, "task_id": 173 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3300191, 47.606314 ], [ -122.3305657, 47.6069485 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952992, "project_id": 13, "task_id": 419 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3307024, 47.6069242 ], [ -122.33059, 47.6069602 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952993, "project_id": 13, "task_id": 419 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330766, 47.6069378 ], [ -122.3307316, 47.606892 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952994, "project_id": 13, "task_id": 419 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3307316, 47.606892 ], [ -122.3307024, 47.6069242 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952995, "project_id": 13, "task_id": 419 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3308703, 47.6070415 ], [ -122.330843, 47.6070184 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952996, "project_id": 13, "task_id": 419 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3305657, 47.6069485 ], [ -122.3305605, 47.606966 ], [ -122.3305553, 47.6069834 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952997, "project_id": 13, "task_id": 419 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33059, 47.6069602 ], [ -122.3305605, 47.606966 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952998, "project_id": 13, "task_id": 419 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330838, 47.6070417 ], [ -122.3307004, 47.6071246 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952999, "project_id": 13, "task_id": 419 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3307004, 47.6071246 ], [ -122.3306759, 47.6071372 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953000, "project_id": 13, "task_id": 419 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330838, 47.6070417 ], [ -122.3308703, 47.6070415 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953009, "project_id": 13, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3367043, 47.6054036 ], [ -122.3363102, 47.6055733 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953010, "project_id": 13, "task_id": 216 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336163, 47.6048065 ], [ -122.3361479, 47.6047635 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953011, "project_id": 13, "task_id": 216 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3362369, 47.6047871 ], [ -122.336163, 47.6048065 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953012, "project_id": 13, "task_id": 460 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314466, 47.6017789 ], [ -122.3314477, 47.6016669 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953013, "project_id": 13, "task_id": 508 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3307499, 47.6018998 ], [ -122.3307243, 47.6018661 ], [ -122.3307325, 47.6018348 ], [ -122.330737, 47.6018184 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953014, "project_id": 13, "task_id": 231 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330179, 47.5999793 ], [ -122.3301771, 47.599966 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953015, "project_id": 13, "task_id": 231 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3301771, 47.599966 ], [ -122.3300367, 47.5999656 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953016, "project_id": 13, "task_id": 231 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330204, 47.5999425 ], [ -122.3301771, 47.599966 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953017, "project_id": 13, "task_id": 231 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3302143, 47.5999378 ], [ -122.330204, 47.5999425 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953018, "project_id": 13, "task_id": 231 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3302143, 47.5999378 ], [ -122.3305145, 47.5999445 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953019, "project_id": 13, "task_id": 244 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291364, 47.5999681 ], [ -122.3291166, 47.60011 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953020, "project_id": 13, "task_id": 244 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3293756, 47.6001202 ], [ -122.3291378, 47.6001217 ], [ -122.3291254, 47.6001426 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953021, "project_id": 13, "task_id": 241 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3293859, 47.5999699 ], [ -122.329167, 47.5999688 ], [ -122.3291552, 47.5999577 ], [ -122.3291441, 47.5999471 ], [ -122.3291475, 47.5998941 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953022, "project_id": 13, "task_id": 244 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291254, 47.6001426 ], [ -122.3291166, 47.60011 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953023, "project_id": 13, "task_id": 244 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3291364, 47.5999681 ], [ -122.3291552, 47.5999577 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953024, "project_id": 13, "task_id": 529 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3300194, 47.6015132 ], [ -122.3296682, 47.6013565 ], [ -122.3296005, 47.6013195 ], [ -122.3295381, 47.6012525 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953025, "project_id": 13, "task_id": 521 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299049, 47.6016178 ], [ -122.3297674, 47.6015681 ], [ -122.3295978, 47.6015084 ], [ -122.3294204, 47.6013896 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953066, "project_id": 13, "task_id": 234 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303999, 47.5998069 ], [ -122.3304718, 47.5998614 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953067, "project_id": 13, "task_id": 118 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3307105, 47.6001155 ], [ -122.3305874, 47.5999844 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953068, "project_id": 13, "task_id": 118 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3306943, 47.6001482 ], [ -122.3304308, 47.6001474 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953069, "project_id": 13, "task_id": 233 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3306813, 47.5999711 ], [ -122.3306157, 47.5999704 ], [ -122.3305904, 47.5999672 ], [ -122.330569, 47.5999644 ], [ -122.3305426, 47.5999396 ], [ -122.330485, 47.5998776 ], [ -122.3304718, 47.5998614 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953070, "project_id": 13, "task_id": 233 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3305904, 47.5999672 ], [ -122.3305874, 47.5999844 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953071, "project_id": 13, "task_id": 233 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3305426, 47.5999396 ], [ -122.3305145, 47.5999445 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953072, "project_id": 13, "task_id": 233 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3304308, 47.6001474 ], [ -122.3303968, 47.6001476 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953073, "project_id": 13, "task_id": 233 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303698, 47.6001415 ], [ -122.3303968, 47.6001476 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953074, "project_id": 13, "task_id": 243 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299466, 47.5999671 ], [ -122.3293859, 47.5999699 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953075, "project_id": 13, "task_id": 232 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3299611, 47.6001164 ], [ -122.3293756, 47.6001202 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953076, "project_id": 13, "task_id": 502 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3295381, 47.6012525 ], [ -122.3292794, 47.6009573 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953077, "project_id": 13, "task_id": 508 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3307202, 47.6018193 ], [ -122.3307325, 47.6018348 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953078, "project_id": 13, "task_id": 508 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330617, 47.6016538 ], [ -122.3306164, 47.6016454 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953079, "project_id": 13, "task_id": 510 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3308743, 47.6006978 ], [ -122.330834, 47.6006516 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953080, "project_id": 13, "task_id": 119 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.330834, 47.6006516 ], [ -122.3305318, 47.600317 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953081, "project_id": 13, "task_id": 511 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3308743, 47.6006978 ], [ -122.3309313, 47.600799 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953082, "project_id": 13, "task_id": 357 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3320201, 47.6019039 ], [ -122.3318933, 47.601795 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953083, "project_id": 13, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3318986, 47.600962 ], [ -122.3317816, 47.6009616 ], [ -122.3317458, 47.6009622 ], [ -122.3317127, 47.6009583 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953084, "project_id": 13, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314353, 47.5999704 ], [ -122.3312573, 47.5999719 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953085, "project_id": 13, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3315299, 47.600127 ], [ -122.3314715, 47.6001303 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953086, "project_id": 13, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331472, 47.6001202 ], [ -122.3314465, 47.6001158 ], [ -122.3312588, 47.6001165 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953087, "project_id": 13, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3315002, 47.6001035 ], [ -122.331472, 47.6001202 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953088, "project_id": 13, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331699, 47.6001364 ], [ -122.3317132, 47.6001364 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953089, "project_id": 13, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317468, 47.6001111 ], [ -122.3317444, 47.6001363 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953090, "project_id": 13, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3317352, 47.5999691 ], [ -122.3317276, 47.599957 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953091, "project_id": 13, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3312588, 47.6001165 ], [ -122.3307428, 47.6001216 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953092, "project_id": 13, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3312573, 47.5999719 ], [ -122.3306813, 47.5999711 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953093, "project_id": 13, "task_id": 118 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3307428, 47.6001216 ], [ -122.3307286, 47.6001296 ], [ -122.3307096, 47.6001406 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953094, "project_id": 13, "task_id": 118 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3306943, 47.6001482 ], [ -122.3307096, 47.6001406 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953095, "project_id": 13, "task_id": 118 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3307105, 47.6001155 ], [ -122.3307286, 47.6001296 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953096, "project_id": 13, "task_id": 121 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3306124, 47.5992717 ], [ -122.3304106, 47.5992752 ], [ -122.3304024, 47.5992826 ], [ -122.3303862, 47.5992976 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953097, "project_id": 13, "task_id": 34 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3303836, 47.5991169 ], [ -122.3303345, 47.5985921 ], [ -122.3304136, 47.5985773 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953098, "project_id": 13, "task_id": 34 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314771, 47.5982101 ], [ -122.3310455, 47.598211 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953099, "project_id": 13, "task_id": 221 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3313752, 47.5984212 ], [ -122.3310627, 47.5984228 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953100, "project_id": 13, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.331758, 47.5982154 ], [ -122.3317261, 47.5978168 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953101, "project_id": 13, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314771, 47.5982101 ], [ -122.331491, 47.5978162 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953102, "project_id": 13, "task_id": 34 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3302849, 47.5970689 ], [ -122.3302884, 47.5974753 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953103, "project_id": 13, "task_id": 34 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3304538, 47.5975181 ], [ -122.3304539, 47.5978763 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953104, "project_id": 13, "task_id": 34 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3304538, 47.5975181 ], [ -122.3303163, 47.5975125 ], [ -122.3303203, 47.5979224 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953105, "project_id": 13, "task_id": 104 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3318228, 47.5992723 ], [ -122.3317469, 47.5992746 ], [ -122.3317225, 47.5992911 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953106, "project_id": 13, "task_id": 105 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314626, 47.5993001 ], [ -122.3314368, 47.5992816 ], [ -122.3312568, 47.5992755 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953107, "project_id": 13, "task_id": 105 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3318228, 47.5991396 ], [ -122.331753, 47.5991385 ], [ -122.3317273, 47.5991252 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953108, "project_id": 13, "task_id": 343 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3325332, 47.6009568 ], [ -122.3318986, 47.600962 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953109, "project_id": 13, "task_id": 206 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332897, 47.5999812 ], [ -122.3319159, 47.5999734 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953110, "project_id": 13, "task_id": 103 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327507, 47.59928 ], [ -122.3324112, 47.5992735 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953111, "project_id": 13, "task_id": 230 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332729, 47.5991342 ], [ -122.3324335, 47.5991343 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953112, "project_id": 13, "task_id": 9 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3383458, 47.6057087 ], [ -122.3381099, 47.605805 ], [ -122.3380364, 47.6058351 ], [ -122.3377961, 47.6059332 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953113, "project_id": 13, "task_id": 9 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3384118, 47.6058594 ], [ -122.337852, 47.6060751 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953114, "project_id": 13, "task_id": 9 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3381099, 47.605805 ], [ -122.3378223, 47.6054939 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953115, "project_id": 13, "task_id": 9 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3380364, 47.6058351 ], [ -122.3377689, 47.6055422 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953116, "project_id": 13, "task_id": 9 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3382598, 47.605359 ], [ -122.3385045, 47.6056277 ], [ -122.3384826, 47.6056554 ], [ -122.3383458, 47.6057087 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953117, "project_id": 13, "task_id": 8 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3385638, 47.6057768 ], [ -122.3385699, 47.6057876 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953118, "project_id": 13, "task_id": 8 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3385699, 47.6057876 ], [ -122.3384118, 47.6058594 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953119, "project_id": 13, "task_id": 8 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3386429, 47.6057742 ], [ -122.338655, 47.6057863 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953120, "project_id": 13, "task_id": 218 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3374397, 47.605263 ], [ -122.3372109, 47.6053577 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953121, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3377671, 47.6051236 ], [ -122.3376407, 47.6051763 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953122, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3378223, 47.6054939 ], [ -122.3375904, 47.6052451 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953123, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3377689, 47.6055422 ], [ -122.3375221, 47.6052728 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953124, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3376032, 47.6051925 ], [ -122.3375735, 47.6052133 ], [ -122.3375904, 47.6052451 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953125, "project_id": 13, "task_id": 350 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3374546, 47.6052612 ], [ -122.3374829, 47.6052509 ], [ -122.3375221, 47.6052728 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953126, "project_id": 13, "task_id": 435 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343174, 47.6016663 ], [ -122.3343116, 47.6018251 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953127, "project_id": 13, "task_id": 435 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343174, 47.6016663 ], [ -122.3340797, 47.6016586 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953128, "project_id": 13, "task_id": 435 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343116, 47.6018251 ], [ -122.3340638, 47.601827 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953129, "project_id": 13, "task_id": 435 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3347254, 47.6016484 ], [ -122.3343659, 47.6016573 ], [ -122.3343509, 47.601647 ], [ -122.3343275, 47.6016309 ], [ -122.3343222, 47.6015206 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953130, "project_id": 13, "task_id": 435 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3344181, 47.6018252 ], [ -122.3343421, 47.6018265 ], [ -122.334329, 47.6018381 ], [ -122.3343129, 47.6018524 ], [ -122.3343129, 47.6019321 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953131, "project_id": 13, "task_id": 435 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343116, 47.6018251 ], [ -122.334329, 47.6018381 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953132, "project_id": 13, "task_id": 435 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343509, 47.601647 ], [ -122.3343174, 47.6016663 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953133, "project_id": 13, "task_id": 490 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3338634, 47.6016509 ], [ -122.3335661, 47.6016497 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953134, "project_id": 13, "task_id": 490 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3338656, 47.6018094 ], [ -122.3338066, 47.6018122 ], [ -122.3337314, 47.601847 ], [ -122.3336545, 47.6018908 ], [ -122.3335633, 47.6019377 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953135, "project_id": 13, "task_id": 491 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340797, 47.6016586 ], [ -122.3340638, 47.601827 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953136, "project_id": 13, "task_id": 491 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340693, 47.6015665 ], [ -122.3340693, 47.6016306 ], [ -122.3340586, 47.6016387 ], [ -122.3340406, 47.6016524 ], [ -122.3338634, 47.6016509 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953137, "project_id": 13, "task_id": 491 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3338656, 47.6018094 ], [ -122.3340276, 47.6018129 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953138, "project_id": 13, "task_id": 491 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340485, 47.6019696 ], [ -122.3340478, 47.6018498 ], [ -122.3340276, 47.6018129 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953139, "project_id": 13, "task_id": 491 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340797, 47.6016586 ], [ -122.3340586, 47.6016387 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953140, "project_id": 13, "task_id": 491 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340638, 47.601827 ], [ -122.3340276, 47.6018129 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953143, "project_id": 13, "task_id": 92 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335134, 47.5991342 ], [ -122.3345588, 47.5991362 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953144, "project_id": 13, "task_id": 92 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3352705, 47.5992857 ], [ -122.3345549, 47.5992818 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953145, "project_id": 13, "task_id": 32 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3348058, 47.5983688 ], [ -122.3348074, 47.5982428 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953146, "project_id": 13, "task_id": 29 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3352604, 47.5982118 ], [ -122.3348103, 47.5982131 ], [ -122.3345825, 47.5982137 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953147, "project_id": 13, "task_id": 29 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335449, 47.5983995 ], [ -122.3348094, 47.5983919 ], [ -122.3345843, 47.5983909 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953148, "project_id": 13, "task_id": 32 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3348058, 47.5983688 ], [ -122.3348094, 47.5983919 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953149, "project_id": 13, "task_id": 32 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3348103, 47.5982131 ], [ -122.3348074, 47.5982428 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953156, "project_id": 13, "task_id": 27 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3361915, 47.5977637 ], [ -122.336185, 47.5973802 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953157, "project_id": 13, "task_id": 30 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3361915, 47.5977637 ], [ -122.3361897, 47.5978273 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953158, "project_id": 13, "task_id": 24 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336185, 47.5973802 ], [ -122.3361851, 47.5971964 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953165, "project_id": 13, "task_id": 223 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330447, 47.5982463 ], [ -122.3330481, 47.5983417 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953166, "project_id": 13, "task_id": 223 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327734, 47.5982424 ], [ -122.3327621, 47.5983638 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953167, "project_id": 13, "task_id": 223 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330303, 47.5985225 ], [ -122.3330275, 47.5983847 ], [ -122.3330474, 47.5983641 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953168, "project_id": 13, "task_id": 223 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330481, 47.5983417 ], [ -122.3330474, 47.5983641 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953169, "project_id": 13, "task_id": 223 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330275, 47.5983847 ], [ -122.332962, 47.5983705 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953170, "project_id": 13, "task_id": 223 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327529, 47.5985158 ], [ -122.3327674, 47.5983785 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953171, "project_id": 13, "task_id": 223 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327734, 47.5982424 ], [ -122.3327692, 47.5982163 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953172, "project_id": 13, "task_id": 111 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3333505, 47.5981635 ], [ -122.3332001, 47.5981768 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953173, "project_id": 13, "task_id": 111 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3331358, 47.5982007 ], [ -122.3331565, 47.5981681 ], [ -122.3331597, 47.5975536 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953174, "project_id": 13, "task_id": 111 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3331597, 47.5975536 ], [ -122.3331134, 47.5975076 ], [ -122.3331107, 47.5971222 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953175, "project_id": 13, "task_id": 111 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3334021, 47.5982114 ], [ -122.33337, 47.5981881 ], [ -122.3333648, 47.5981708 ], [ -122.3333648, 47.5981626 ], [ -122.3333595, 47.597328 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953176, "project_id": 13, "task_id": 111 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3333505, 47.5981635 ], [ -122.3333648, 47.5981626 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953177, "project_id": 13, "task_id": 108 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3339949, 47.5982085 ], [ -122.3334021, 47.5982114 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953178, "project_id": 13, "task_id": 26 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340454, 47.5981406 ], [ -122.3340362, 47.596667 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953179, "project_id": 13, "task_id": 26 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343734, 47.5980679 ], [ -122.3343651, 47.5966593 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953180, "project_id": 13, "task_id": 26 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343533, 47.5966053 ], [ -122.3342865, 47.5966057 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953181, "project_id": 13, "task_id": 26 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343533, 47.5966053 ], [ -122.3343846, 47.5966145 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953182, "project_id": 13, "task_id": 24 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3348837, 47.5972538 ], [ -122.3344477, 47.596619 ], [ -122.3343846, 47.5966145 ], [ -122.3343651, 47.5966593 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953183, "project_id": 13, "task_id": 26 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3331427, 47.5968369 ], [ -122.3331408, 47.5958853 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953184, "project_id": 13, "task_id": 73 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3333789, 47.5967858 ], [ -122.3333448, 47.5959421 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953185, "project_id": 13, "task_id": 73 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3342865, 47.5966057 ], [ -122.3340819, 47.5966078 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953186, "project_id": 13, "task_id": 73 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3344182, 47.5965607 ], [ -122.3344133, 47.5963402 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953187, "project_id": 13, "task_id": 73 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340819, 47.5966078 ], [ -122.3340365, 47.5966087 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953188, "project_id": 13, "task_id": 26 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340362, 47.596667 ], [ -122.3340365, 47.5966087 ], [ -122.3340394, 47.5962748 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953189, "project_id": 13, "task_id": 73 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340394, 47.5962748 ], [ -122.3340469, 47.5962277 ], [ -122.3339976, 47.5961882 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953190, "project_id": 13, "task_id": 73 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3344182, 47.5965607 ], [ -122.3344192, 47.5965807 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953191, "project_id": 13, "task_id": 348 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3373261, 47.6024229 ], [ -122.3371576, 47.6024899 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953192, "project_id": 13, "task_id": 348 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3369043, 47.6022984 ], [ -122.3370268, 47.6022577 ], [ -122.3371422, 47.6022087 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953193, "project_id": 13, "task_id": 348 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3366015, 47.6024482 ], [ -122.3365834, 47.6024901 ], [ -122.336434, 47.6025587 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953194, "project_id": 13, "task_id": 211 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3373261, 47.6024229 ], [ -122.3373212, 47.6023829 ], [ -122.3371422, 47.6022087 ], [ -122.3369808, 47.6020517 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953195, "project_id": 13, "task_id": 348 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3371576, 47.6024899 ], [ -122.3371373, 47.6024937 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953196, "project_id": 13, "task_id": 348 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3371373, 47.6024937 ], [ -122.3370917, 47.6025063 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953197, "project_id": 13, "task_id": 30 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3357571, 47.5980763 ], [ -122.3355574, 47.5980786 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953198, "project_id": 13, "task_id": 29 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354266, 47.5982007 ], [ -122.3353887, 47.5982095 ], [ -122.3352604, 47.5982118 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953199, "project_id": 13, "task_id": 29 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355072, 47.5984342 ], [ -122.3355087, 47.5984623 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953200, "project_id": 13, "task_id": 29 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355087, 47.5984623 ], [ -122.3355051, 47.5989302 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953201, "project_id": 13, "task_id": 204 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3357567, 47.5984251 ], [ -122.3357349, 47.5984239 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953202, "project_id": 13, "task_id": 25 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3350525, 47.5965693 ], [ -122.3344917, 47.596568 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953203, "project_id": 13, "task_id": 33 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.334315, 47.5982058 ], [ -122.3340845, 47.598205 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953204, "project_id": 13, "task_id": 109 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340317, 47.5982406 ], [ -122.3340608, 47.5983705 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953205, "project_id": 13, "task_id": 109 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340454, 47.5981406 ], [ -122.3340477, 47.5981789 ], [ -122.3340315, 47.5982128 ], [ -122.3339949, 47.5982085 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953206, "project_id": 13, "task_id": 109 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340315, 47.5982128 ], [ -122.3340317, 47.5982406 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953207, "project_id": 13, "task_id": 109 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340845, 47.598205 ], [ -122.3340477, 47.5981789 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953208, "project_id": 13, "task_id": 109 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340608, 47.5983705 ], [ -122.3340472, 47.5983826 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953209, "project_id": 13, "task_id": 33 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343739, 47.5982532 ], [ -122.3343669, 47.5983631 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953210, "project_id": 13, "task_id": 32 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3345825, 47.5982137 ], [ -122.3344132, 47.5982164 ], [ -122.3343824, 47.5982058 ], [ -122.3343663, 47.5982002 ], [ -122.3343734, 47.5980679 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953211, "project_id": 13, "task_id": 33 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343824, 47.5982058 ], [ -122.3343739, 47.5982532 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953212, "project_id": 13, "task_id": 33 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343663, 47.5982002 ], [ -122.334315, 47.5982058 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953213, "project_id": 13, "task_id": 32 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3345843, 47.5983909 ], [ -122.3343704, 47.5983881 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953214, "project_id": 13, "task_id": 33 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343704, 47.5983881 ], [ -122.3343335, 47.5983989 ], [ -122.3343358, 47.5985719 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953215, "project_id": 13, "task_id": 33 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343669, 47.5983631 ], [ -122.3343704, 47.5983881 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953216, "project_id": 13, "task_id": 33 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343358, 47.5985719 ], [ -122.3343286, 47.5988787 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953217, "project_id": 13, "task_id": 113 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.334075, 47.5985294 ], [ -122.3340674, 47.5988787 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953218, "project_id": 13, "task_id": 223 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330361, 47.5989453 ], [ -122.3330303, 47.5985225 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953219, "project_id": 13, "task_id": 223 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327699, 47.598941 ], [ -122.3327529, 47.5985158 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953244, "project_id": 13, "task_id": 224 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3329499, 47.5991012 ], [ -122.3328329, 47.599104 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953245, "project_id": 13, "task_id": 224 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3328069, 47.5991373 ], [ -122.3328106, 47.599265 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953246, "project_id": 13, "task_id": 224 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3329926, 47.5991367 ], [ -122.3329885, 47.5991777 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953247, "project_id": 13, "task_id": 224 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3329899, 47.5992 ], [ -122.3329896, 47.5992667 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953248, "project_id": 13, "task_id": 224 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3329885, 47.5991777 ], [ -122.3329895, 47.5991924 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953249, "project_id": 13, "task_id": 224 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3329899, 47.5992 ], [ -122.3329895, 47.5991924 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953250, "project_id": 13, "task_id": 224 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327699, 47.598941 ], [ -122.3327821, 47.5990998 ], [ -122.3327562, 47.5991166 ], [ -122.332729, 47.5991342 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953251, "project_id": 13, "task_id": 224 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3328069, 47.5991373 ], [ -122.3327562, 47.5991166 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953252, "project_id": 13, "task_id": 224 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3328329, 47.599104 ], [ -122.3327821, 47.5990998 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953253, "project_id": 13, "task_id": 224 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330361, 47.5989453 ], [ -122.3330341, 47.5990848 ], [ -122.3330381, 47.5991105 ], [ -122.3330688, 47.5991292 ], [ -122.3332231, 47.5991312 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953254, "project_id": 13, "task_id": 224 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330341, 47.5990848 ], [ -122.3329499, 47.5991012 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953255, "project_id": 13, "task_id": 224 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330381, 47.5991105 ], [ -122.3329926, 47.5991367 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953256, "project_id": 13, "task_id": 224 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3332228, 47.5991939 ], [ -122.3329895, 47.5991924 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953257, "project_id": 13, "task_id": 225 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3336939, 47.5991332 ], [ -122.3336288, 47.5991332 ], [ -122.3332231, 47.5991312 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953258, "project_id": 13, "task_id": 225 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3332228, 47.5991939 ], [ -122.3336281, 47.5991995 ], [ -122.3336405, 47.5991996 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953259, "project_id": 13, "task_id": 225 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3336281, 47.5991888 ], [ -122.333629, 47.5991491 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953260, "project_id": 13, "task_id": 225 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3336281, 47.5991888 ], [ -122.3336281, 47.5991995 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953261, "project_id": 13, "task_id": 225 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333629, 47.5991491 ], [ -122.3336288, 47.5991332 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953262, "project_id": 13, "task_id": 113 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340674, 47.5988787 ], [ -122.3340623, 47.5991148 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953263, "project_id": 13, "task_id": 113 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343286, 47.5988787 ], [ -122.3343366, 47.5990302 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953264, "project_id": 13, "task_id": 114 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343361, 47.5992674 ], [ -122.3341882, 47.5992837 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953265, "project_id": 13, "task_id": 114 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343226, 47.5991491 ], [ -122.3343361, 47.5992674 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953266, "project_id": 13, "task_id": 114 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343226, 47.5991491 ], [ -122.334191, 47.5991362 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953267, "project_id": 13, "task_id": 92 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3345588, 47.5991362 ], [ -122.3343728, 47.5991374 ], [ -122.33435, 47.5991303 ], [ -122.3343335, 47.5991253 ], [ -122.3343366, 47.5990302 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953268, "project_id": 13, "task_id": 92 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3345549, 47.5992818 ], [ -122.334338, 47.599283 ], [ -122.3343533, 47.5997401 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953269, "project_id": 13, "task_id": 114 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343361, 47.5992674 ], [ -122.334338, 47.599283 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953270, "project_id": 13, "task_id": 114 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33435, 47.5991303 ], [ -122.3343226, 47.5991491 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953276, "project_id": 13, "task_id": 114 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.334191, 47.5991362 ], [ -122.3340871, 47.5991295 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953277, "project_id": 13, "task_id": 208 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340871, 47.5991295 ], [ -122.3340763, 47.5992795 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953278, "project_id": 13, "task_id": 114 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3341882, 47.5992837 ], [ -122.3340763, 47.5992795 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953279, "project_id": 13, "task_id": 208 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340639, 47.5999325 ], [ -122.3340731, 47.5993055 ], [ -122.3340556, 47.5992857 ], [ -122.3339725, 47.5992816 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953280, "project_id": 13, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340623, 47.5991148 ], [ -122.334058, 47.5991206 ], [ -122.3340494, 47.5991333 ], [ -122.3339607, 47.5991347 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953281, "project_id": 13, "task_id": 208 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340763, 47.5992795 ], [ -122.3340556, 47.5992857 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953282, "project_id": 13, "task_id": 208 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340871, 47.5991295 ], [ -122.334058, 47.5991206 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953283, "project_id": 13, "task_id": 208 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3339725, 47.5992816 ], [ -122.333218, 47.5992829 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953284, "project_id": 13, "task_id": 207 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3339607, 47.5991347 ], [ -122.3336939, 47.5991332 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953285, "project_id": 13, "task_id": 229 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.333218, 47.5992829 ], [ -122.3330393, 47.5992818 ], [ -122.3329893, 47.5992815 ], [ -122.3328103, 47.5992804 ], [ -122.3327759, 47.5992802 ], [ -122.3327507, 47.59928 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953286, "project_id": 13, "task_id": 229 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3329896, 47.5992667 ], [ -122.3329893, 47.5992815 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953287, "project_id": 13, "task_id": 229 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3328106, 47.599265 ], [ -122.3328103, 47.5992804 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953288, "project_id": 13, "task_id": 229 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330393, 47.5992818 ], [ -122.3330473, 47.599784 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953289, "project_id": 13, "task_id": 229 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.332786, 47.5998151 ], [ -122.3327759, 47.5992802 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953290, "project_id": 13, "task_id": 342 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3335519, 47.6001076 ], [ -122.3335476, 47.5999878 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953291, "project_id": 13, "task_id": 340 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3338389, 47.5999647 ], [ -122.332897, 47.5999812 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953293, "project_id": 13, "task_id": 340 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340821, 47.6001288 ], [ -122.3340809, 47.5999742 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953294, "project_id": 13, "task_id": 205 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3341924, 47.5999706 ], [ -122.3340809, 47.5999742 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953295, "project_id": 13, "task_id": 340 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3341858, 47.6001302 ], [ -122.3340821, 47.6001288 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953296, "project_id": 13, "task_id": 340 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340639, 47.5999325 ], [ -122.3340522, 47.5999438 ], [ -122.3340302, 47.599965 ], [ -122.3338389, 47.5999647 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953297, "project_id": 13, "task_id": 340 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3339729, 47.6001263 ], [ -122.3340346, 47.6001233 ], [ -122.334053, 47.6001422 ], [ -122.3340625, 47.600152 ], [ -122.3340567, 47.6004745 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953298, "project_id": 13, "task_id": 340 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340809, 47.5999742 ], [ -122.3340522, 47.5999438 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953299, "project_id": 13, "task_id": 340 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340821, 47.6001288 ], [ -122.334053, 47.6001422 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953301, "project_id": 13, "task_id": 205 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343256, 47.599985 ], [ -122.3343163, 47.6001137 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953302, "project_id": 13, "task_id": 205 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3341858, 47.6001302 ], [ -122.3343163, 47.6001137 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953303, "project_id": 13, "task_id": 205 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343256, 47.599985 ], [ -122.3341924, 47.5999706 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953304, "project_id": 13, "task_id": 95 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3345465, 47.5999768 ], [ -122.3343789, 47.5999768 ], [ -122.3343453, 47.5999663 ], [ -122.3343533, 47.5997401 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953305, "project_id": 13, "task_id": 205 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.334537, 47.6001265 ], [ -122.3343548, 47.6001241 ], [ -122.334344, 47.6001371 ], [ -122.3343349, 47.600148 ], [ -122.3343478, 47.6004736 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953306, "project_id": 13, "task_id": 205 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343453, 47.5999663 ], [ -122.3343256, 47.599985 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953307, "project_id": 13, "task_id": 205 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.334344, 47.6001371 ], [ -122.3343163, 47.6001137 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953308, "project_id": 13, "task_id": 95 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3352537, 47.5999762 ], [ -122.3345465, 47.5999768 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953309, "project_id": 13, "task_id": 95 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3352487, 47.6001177 ], [ -122.334537, 47.6001265 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953310, "project_id": 13, "task_id": 496 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3335381, 47.6009412 ], [ -122.3335381, 47.6008348 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953311, "project_id": 13, "task_id": 344 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3338292, 47.6008125 ], [ -122.3332013, 47.6008066 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953312, "project_id": 13, "task_id": 427 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327431, 47.6016396 ], [ -122.332744, 47.601663 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953313, "project_id": 13, "task_id": 427 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33277, 47.6016387 ], [ -122.3327501, 47.6016393 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953314, "project_id": 13, "task_id": 427 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330317, 47.6017818 ], [ -122.3330315, 47.6018018 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953315, "project_id": 13, "task_id": 344 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3327501, 47.6016393 ], [ -122.3327465, 47.6013099 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953316, "project_id": 13, "task_id": 427 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3330398, 47.6016413 ], [ -122.333051, 47.6013151 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953328, "project_id": 13, "task_id": 339 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33408, 47.6009522 ], [ -122.3340632, 47.6008272 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953329, "project_id": 13, "task_id": 339 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33408, 47.6009522 ], [ -122.3341847, 47.6009589 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953330, "project_id": 13, "task_id": 339 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3341825, 47.6008047 ], [ -122.3340729, 47.6008075 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953331, "project_id": 13, "task_id": 339 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340567, 47.6004745 ], [ -122.3340561, 47.6007751 ], [ -122.3340369, 47.6007962 ], [ -122.3340203, 47.6008148 ], [ -122.3338292, 47.6008125 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953332, "project_id": 13, "task_id": 339 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340632, 47.6008272 ], [ -122.3340203, 47.6008148 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953333, "project_id": 13, "task_id": 339 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3339712, 47.6009646 ], [ -122.3340493, 47.6009719 ], [ -122.3340672, 47.6009926 ], [ -122.3340664, 47.6011427 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953334, "project_id": 13, "task_id": 339 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33408, 47.6009522 ], [ -122.3340493, 47.6009719 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953339, "project_id": 13, "task_id": 491 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340664, 47.6011427 ], [ -122.3340693, 47.6015665 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953340, "project_id": 13, "task_id": 341 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343413, 47.6011762 ], [ -122.3343222, 47.6015206 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953346, "project_id": 13, "task_id": 341 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343309, 47.6009617 ], [ -122.3341847, 47.6009589 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953347, "project_id": 13, "task_id": 341 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343421, 47.6008193 ], [ -122.3343309, 47.6009617 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953348, "project_id": 13, "task_id": 339 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3341825, 47.6008047 ], [ -122.3343087, 47.6008036 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953349, "project_id": 13, "task_id": 97 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354115, 47.6008314 ], [ -122.3343823, 47.600819 ], [ -122.3343731, 47.6008127 ], [ -122.3343504, 47.6007971 ], [ -122.3343453, 47.6007935 ], [ -122.3343478, 47.6004736 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953350, "project_id": 13, "task_id": 341 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343974, 47.6009646 ], [ -122.334361, 47.6009634 ], [ -122.3343406, 47.600981 ], [ -122.3343413, 47.6011762 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953351, "project_id": 13, "task_id": 341 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343309, 47.6009617 ], [ -122.334361, 47.6009634 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953352, "project_id": 13, "task_id": 341 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343309, 47.6009617 ], [ -122.3343406, 47.600981 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953353, "project_id": 13, "task_id": 341 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343731, 47.6008127 ], [ -122.3343421, 47.6008193 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953354, "project_id": 13, "task_id": 341 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343087, 47.6008036 ], [ -122.3343504, 47.6007971 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953355, "project_id": 13, "task_id": 339 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340729, 47.6008075 ], [ -122.3340369, 47.6007962 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953375, "project_id": 13, "task_id": 214 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3383976, 47.6015511 ], [ -122.3365885, 47.6015525 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953390, "project_id": 13, "task_id": 349 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3381598, 47.6049638 ], [ -122.3380791, 47.6048638 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953391, "project_id": 13, "task_id": 349 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3380147, 47.6048607 ], [ -122.3378733, 47.6048924 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953392, "project_id": 13, "task_id": 349 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3381873, 47.6049599 ], [ -122.3381821, 47.6049681 ], [ -122.3381781, 47.6049747 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953393, "project_id": 13, "task_id": 349 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3381598, 47.6049638 ], [ -122.3381821, 47.6049681 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953394, "project_id": 13, "task_id": 349 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3379377, 47.6050442 ], [ -122.3377671, 47.6051236 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953395, "project_id": 13, "task_id": 8 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3382598, 47.605359 ], [ -122.338004, 47.6050553 ], [ -122.3379377, 47.6050442 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953396, "project_id": 13, "task_id": 349 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3380205, 47.6050304 ], [ -122.338004, 47.6050553 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953397, "project_id": 13, "task_id": 349 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3379433, 47.6050142 ], [ -122.3379377, 47.6050442 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953398, "project_id": 13, "task_id": 349 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.337859, 47.6049069 ], [ -122.3378515, 47.6049277 ], [ -122.337847, 47.6049403 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953399, "project_id": 13, "task_id": 349 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3378827, 47.6049386 ], [ -122.3378515, 47.6049277 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953400, "project_id": 13, "task_id": 349 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3378733, 47.6048924 ], [ -122.337859, 47.6049069 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953401, "project_id": 13, "task_id": 349 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3383878, 47.6047252 ], [ -122.3381364, 47.6048295 ], [ -122.3380854, 47.6048279 ], [ -122.3380476, 47.6048266 ], [ -122.3380349, 47.6048262 ], [ -122.3377613, 47.6045207 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953402, "project_id": 13, "task_id": 349 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3380854, 47.6048279 ], [ -122.3380791, 47.6048638 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953403, "project_id": 13, "task_id": 349 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3380147, 47.6048607 ], [ -122.3380476, 47.6048266 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953408, "project_id": 13, "task_id": 486 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3379342, 47.6038672 ], [ -122.33778, 47.6036951 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953409, "project_id": 13, "task_id": 485 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3377399, 47.603232 ], [ -122.3375461, 47.6033212 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953410, "project_id": 13, "task_id": 484 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3378103, 47.6031999 ], [ -122.3377747, 47.6032139 ], [ -122.337769, 47.6032257 ], [ -122.337763, 47.6032384 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953411, "project_id": 13, "task_id": 485 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.337769, 47.6032257 ], [ -122.3377399, 47.603232 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953412, "project_id": 13, "task_id": 485 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.33778, 47.6036951 ], [ -122.3374737, 47.6033464 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953413, "project_id": 13, "task_id": 485 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3375461, 47.6033212 ], [ -122.3374737, 47.6033464 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953416, "project_id": 13, "task_id": 488 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3374315, 47.6032979 ], [ -122.3373434, 47.6031956 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953417, "project_id": 13, "task_id": 488 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3375767, 47.6030332 ], [ -122.3373542, 47.6031055 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953418, "project_id": 13, "task_id": 485 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3374737, 47.6033464 ], [ -122.3374302, 47.6033257 ], [ -122.3371543, 47.6034403 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953419, "project_id": 13, "task_id": 488 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3373147, 47.6032244 ], [ -122.3371083, 47.6033303 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953420, "project_id": 13, "task_id": 488 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3375767, 47.6030332 ], [ -122.3376086, 47.6030144 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953421, "project_id": 13, "task_id": 488 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3373542, 47.6031055 ], [ -122.3372806, 47.6031245 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953422, "project_id": 13, "task_id": 484 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.337689, 47.6029972 ], [ -122.3376086, 47.6030144 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953423, "project_id": 13, "task_id": 488 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3374315, 47.6032979 ], [ -122.3374302, 47.6033257 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953424, "project_id": 13, "task_id": 488 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3373147, 47.6032244 ], [ -122.3373073, 47.6031913 ], [ -122.3372806, 47.6031245 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953425, "project_id": 13, "task_id": 488 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3373434, 47.6031956 ], [ -122.3373073, 47.6031913 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953426, "project_id": 13, "task_id": 484 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3379544, 47.6031325 ], [ -122.3378984, 47.6031578 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953427, "project_id": 13, "task_id": 484 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3378851, 47.6031643 ], [ -122.3378103, 47.6031999 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953428, "project_id": 13, "task_id": 484 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3378984, 47.6031578 ], [ -122.3378851, 47.6031643 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953429, "project_id": 13, "task_id": 484 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3379544, 47.6031325 ], [ -122.3379669, 47.6031263 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953430, "project_id": 13, "task_id": 484 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3379669, 47.6031263 ], [ -122.3379453, 47.6031019 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953431, "project_id": 13, "task_id": 484 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3379453, 47.6031019 ], [ -122.3379249, 47.6030832 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953432, "project_id": 13, "task_id": 484 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3380653, 47.6031686 ], [ -122.3375637, 47.602617 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953433, "project_id": 13, "task_id": 349 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3377613, 47.6045207 ], [ -122.3375553, 47.6042986 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953434, "project_id": 13, "task_id": 353 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3372087, 47.6042252 ], [ -122.3371805, 47.6042115 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953435, "project_id": 13, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3366282, 47.6036322 ], [ -122.3365503, 47.6035447 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953436, "project_id": 13, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3368745, 47.6035311 ], [ -122.3367915, 47.6034442 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953437, "project_id": 13, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3367179, 47.6034218 ], [ -122.3365793, 47.6034738 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953438, "project_id": 13, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3371543, 47.6034403 ], [ -122.336908, 47.6035348 ], [ -122.3369004, 47.6035806 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953439, "project_id": 13, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3368745, 47.6035311 ], [ -122.336908, 47.6035348 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953440, "project_id": 13, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3368586, 47.6035608 ], [ -122.3369004, 47.6035806 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953441, "project_id": 13, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3366838, 47.6036551 ], [ -122.3366358, 47.6036585 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953442, "project_id": 13, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336698, 47.603633 ], [ -122.3366838, 47.6036551 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953443, "project_id": 13, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3366358, 47.6036585 ], [ -122.3366282, 47.6036322 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953444, "project_id": 13, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3367915, 47.6034442 ], [ -122.3367842, 47.6034307 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953445, "project_id": 13, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3365503, 47.6035447 ], [ -122.3365288, 47.6035285 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953446, "project_id": 13, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3371083, 47.6033303 ], [ -122.336842, 47.6034367 ], [ -122.3367513, 47.6034243 ], [ -122.3367394, 47.6034118 ], [ -122.3362282, 47.6028586 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953447, "project_id": 13, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3365288, 47.6035285 ], [ -122.3364267, 47.603571 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953448, "project_id": 13, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3365288, 47.6035285 ], [ -122.3365455, 47.6034841 ], [ -122.3360503, 47.6029516 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953449, "project_id": 13, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3367394, 47.6034118 ], [ -122.3367179, 47.6034218 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953450, "project_id": 13, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3365793, 47.6034738 ], [ -122.3365455, 47.6034841 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953461, "project_id": 13, "task_id": 513 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354, 47.6039765 ], [ -122.3350327, 47.6041415 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953462, "project_id": 13, "task_id": 514 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3349908, 47.6031382 ], [ -122.3347082, 47.6028265 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953463, "project_id": 13, "task_id": 497 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3342124, 47.6026658 ], [ -122.3341244, 47.6025675 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953464, "project_id": 13, "task_id": 497 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3344369, 47.6025911 ], [ -122.3342124, 47.6026658 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953465, "project_id": 13, "task_id": 497 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343373, 47.6024656 ], [ -122.3341442, 47.6025281 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953466, "project_id": 13, "task_id": 497 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3347082, 47.6028265 ], [ -122.3344842, 47.6025754 ], [ -122.3343728, 47.6024504 ], [ -122.3343579, 47.6024336 ], [ -122.3343352, 47.6023299 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953467, "project_id": 13, "task_id": 497 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3342486, 47.6026847 ], [ -122.3342188, 47.6026828 ], [ -122.3342018, 47.6026818 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953468, "project_id": 13, "task_id": 497 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340041, 47.602385 ], [ -122.334111, 47.6025316 ], [ -122.3341134, 47.6025343 ], [ -122.3341105, 47.6025537 ], [ -122.3339945, 47.6026046 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953469, "project_id": 13, "task_id": 497 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3342124, 47.6026658 ], [ -122.3342188, 47.6026828 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953470, "project_id": 13, "task_id": 497 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3341244, 47.6025675 ], [ -122.3341105, 47.6025537 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953471, "project_id": 13, "task_id": 497 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3341442, 47.6025281 ], [ -122.334111, 47.6025316 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953472, "project_id": 13, "task_id": 497 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3344842, 47.6025754 ], [ -122.3344369, 47.6025911 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953473, "project_id": 13, "task_id": 497 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343728, 47.6024504 ], [ -122.3343373, 47.6024656 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953499, "project_id": 13, "task_id": 435 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3343129, 47.6019321 ], [ -122.3343352, 47.6023299 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953500, "project_id": 13, "task_id": 491 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3340485, 47.6019696 ], [ -122.3340663, 47.6023729 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953501, "project_id": 13, "task_id": 436 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3362305, 47.6028344 ], [ -122.3362292, 47.6028449 ], [ -122.3362282, 47.6028586 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953502, "project_id": 13, "task_id": 436 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3362017, 47.6028511 ], [ -122.3360926, 47.6028988 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953503, "project_id": 13, "task_id": 436 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3362292, 47.6028449 ], [ -122.3362017, 47.6028511 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953504, "project_id": 13, "task_id": 436 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3362305, 47.6028344 ], [ -122.3362133, 47.6028213 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953505, "project_id": 13, "task_id": 436 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3362133, 47.6028213 ], [ -122.3361981, 47.6028104 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953508, "project_id": 13, "task_id": 437 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358232, 47.602997 ], [ -122.3357072, 47.6030451 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953509, "project_id": 13, "task_id": 512 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355281, 47.6029318 ], [ -122.3350876, 47.602451 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953510, "project_id": 13, "task_id": 437 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3359946, 47.6029091 ], [ -122.3358896, 47.6028109 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953511, "project_id": 13, "task_id": 437 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360515, 47.6027047 ], [ -122.3359066, 47.602768 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953512, "project_id": 13, "task_id": 437 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3361048, 47.6027186 ], [ -122.3361981, 47.6028104 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953513, "project_id": 13, "task_id": 437 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360926, 47.6028988 ], [ -122.3360415, 47.6029156 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953514, "project_id": 13, "task_id": 437 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358938, 47.6027778 ], [ -122.3358722, 47.6028025 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953515, "project_id": 13, "task_id": 348 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336434, 47.6025587 ], [ -122.336119, 47.6026976 ], [ -122.3360655, 47.6026885 ], [ -122.3357356, 47.6023089 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953516, "project_id": 13, "task_id": 437 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358722, 47.6028025 ], [ -122.3358896, 47.6028109 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953517, "project_id": 13, "task_id": 437 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3359066, 47.602768 ], [ -122.3358938, 47.6027778 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953518, "project_id": 13, "task_id": 437 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360655, 47.6026885 ], [ -122.3360515, 47.6027047 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953519, "project_id": 13, "task_id": 437 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336119, 47.6026976 ], [ -122.3361048, 47.6027186 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953520, "project_id": 13, "task_id": 436 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360503, 47.6029516 ], [ -122.3360319, 47.602931 ], [ -122.3360049, 47.6029196 ], [ -122.3358232, 47.602997 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953521, "project_id": 13, "task_id": 437 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360415, 47.6029156 ], [ -122.3360319, 47.602931 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953522, "project_id": 13, "task_id": 437 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3359946, 47.6029091 ], [ -122.3360049, 47.6029196 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953525, "project_id": 13, "task_id": 438 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3349613, 47.6018273 ], [ -122.3349526, 47.6018356 ], [ -122.334956, 47.6022924 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953526, "project_id": 13, "task_id": 438 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3350876, 47.602451 ], [ -122.334956, 47.6022924 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953527, "project_id": 13, "task_id": 437 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3356004, 47.6018803 ], [ -122.3355989, 47.6021392 ], [ -122.3356125, 47.6021857 ], [ -122.3357356, 47.6023089 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953528, "project_id": 13, "task_id": 440 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358608, 47.6016586 ], [ -122.3356996, 47.6016554 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953529, "project_id": 13, "task_id": 440 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355211, 47.6016584 ], [ -122.3355453, 47.6016596 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953530, "project_id": 13, "task_id": 440 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3356996, 47.6016554 ], [ -122.3356631, 47.6016535 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953531, "project_id": 13, "task_id": 440 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3356631, 47.6016535 ], [ -122.3355453, 47.6016596 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953532, "project_id": 13, "task_id": 212 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3365701, 47.6018462 ], [ -122.3361171, 47.6018158 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953533, "project_id": 13, "task_id": 212 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3361171, 47.6018158 ], [ -122.335928, 47.6016644 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953534, "project_id": 13, "task_id": 212 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336151, 47.6018624 ], [ -122.336114, 47.6018351 ], [ -122.336051, 47.6018272 ], [ -122.335927, 47.6018319 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953535, "project_id": 13, "task_id": 212 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3361171, 47.6018158 ], [ -122.336114, 47.6018351 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953536, "project_id": 13, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3365885, 47.6015525 ], [ -122.3362202, 47.6010755 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953537, "project_id": 13, "task_id": 211 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3365885, 47.6015525 ], [ -122.3365551, 47.6015835 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953538, "project_id": 13, "task_id": 211 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3365551, 47.6015835 ], [ -122.336696, 47.6017506 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953539, "project_id": 13, "task_id": 211 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336696, 47.6017506 ], [ -122.3367203, 47.6017788 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953540, "project_id": 13, "task_id": 211 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3367203, 47.6017788 ], [ -122.3367733, 47.6018376 ], [ -122.3369808, 47.6020517 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953541, "project_id": 13, "task_id": 211 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3366775, 47.6018434 ], [ -122.336586, 47.6018468 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953542, "project_id": 13, "task_id": 211 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336586, 47.6018468 ], [ -122.3365701, 47.6018462 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953543, "project_id": 13, "task_id": 211 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3367733, 47.6018376 ], [ -122.3366775, 47.6018434 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953544, "project_id": 13, "task_id": 98 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335928, 47.6016644 ], [ -122.3358987, 47.6016427 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953545, "project_id": 13, "task_id": 98 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358987, 47.6016427 ], [ -122.335593, 47.6012037 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953546, "project_id": 13, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358354, 47.6009631 ], [ -122.3355943, 47.6009575 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953547, "project_id": 13, "task_id": 97 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355943, 47.6009575 ], [ -122.3354967, 47.6009598 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953548, "project_id": 13, "task_id": 97 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354758, 47.6008057 ], [ -122.3354115, 47.6008314 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953549, "project_id": 13, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3359138, 47.6008092 ], [ -122.3358555, 47.6008065 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953550, "project_id": 13, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358555, 47.6008065 ], [ -122.3358411, 47.6008053 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953551, "project_id": 13, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358022, 47.600803 ], [ -122.3358255, 47.6008041 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953552, "project_id": 13, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358411, 47.6008053 ], [ -122.3358255, 47.6008041 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953553, "project_id": 13, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3362202, 47.6010755 ], [ -122.3361599, 47.6009683 ], [ -122.3361364, 47.6009265 ], [ -122.3361129, 47.600813 ], [ -122.3361085, 47.600792 ], [ -122.3360902, 47.6005213 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953554, "project_id": 13, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3361183, 47.6009703 ], [ -122.3360712, 47.60097 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953555, "project_id": 13, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360276, 47.6009665 ], [ -122.3359687, 47.6009645 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953556, "project_id": 13, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360587, 47.6009681 ], [ -122.3360367, 47.6009676 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953557, "project_id": 13, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360712, 47.60097 ], [ -122.3360587, 47.6009681 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953558, "project_id": 13, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360367, 47.6009676 ], [ -122.3360276, 47.6009665 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953559, "project_id": 13, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3361183, 47.6009703 ], [ -122.3361599, 47.6009683 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953560, "project_id": 13, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360799, 47.600814 ], [ -122.3360355, 47.6008142 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953561, "project_id": 13, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360355, 47.6008142 ], [ -122.336028, 47.6008142 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953562, "project_id": 13, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336028, 47.6008142 ], [ -122.3360074, 47.6008136 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953563, "project_id": 13, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360799, 47.600814 ], [ -122.3361129, 47.600813 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953564, "project_id": 13, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360074, 47.6008136 ], [ -122.335999, 47.6008131 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953565, "project_id": 13, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335999, 47.6008131 ], [ -122.3359138, 47.6008092 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953566, "project_id": 13, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3359687, 47.6009645 ], [ -122.335882, 47.6009633 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953567, "project_id": 13, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335882, 47.6009633 ], [ -122.3358708, 47.6009622 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953568, "project_id": 13, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358354, 47.6009631 ], [ -122.3358478, 47.6009622 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953569, "project_id": 13, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358708, 47.6009622 ], [ -122.3358478, 47.6009622 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953570, "project_id": 13, "task_id": 202 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360863, 47.6004998 ], [ -122.3360418, 47.6003135 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953571, "project_id": 13, "task_id": 202 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360902, 47.6005213 ], [ -122.3360863, 47.6004998 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953572, "project_id": 13, "task_id": 202 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360333, 47.6002821 ], [ -122.3360347, 47.6001327 ], [ -122.3360366, 47.599961 ], [ -122.3360372, 47.599907 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953573, "project_id": 13, "task_id": 202 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360418, 47.6003135 ], [ -122.3360333, 47.6002821 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953574, "project_id": 13, "task_id": 200 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3359957, 47.6001308 ], [ -122.3358496, 47.6001264 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953575, "project_id": 13, "task_id": 200 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3359994, 47.5999601 ], [ -122.3358575, 47.5999595 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953576, "project_id": 13, "task_id": 200 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360347, 47.6001327 ], [ -122.3359957, 47.6001308 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953577, "project_id": 13, "task_id": 200 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360366, 47.599961 ], [ -122.3359994, 47.5999601 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953578, "project_id": 13, "task_id": 200 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358496, 47.6001264 ], [ -122.3358278, 47.6001243 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953579, "project_id": 13, "task_id": 200 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358575, 47.5999595 ], [ -122.3358375, 47.599961 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953580, "project_id": 13, "task_id": 200 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358278, 47.6001243 ], [ -122.335792, 47.6001218 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953581, "project_id": 13, "task_id": 200 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3358375, 47.599961 ], [ -122.335788, 47.5999617 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953582, "project_id": 13, "task_id": 95 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3353848, 47.6001183 ], [ -122.3352487, 47.6001177 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953583, "project_id": 13, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354518, 47.5999773 ], [ -122.3352537, 47.5999762 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953584, "project_id": 13, "task_id": 200 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360372, 47.599907 ], [ -122.3360388, 47.5994864 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953585, "project_id": 13, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3359964, 47.5993392 ], [ -122.335811, 47.5993358 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953586, "project_id": 13, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336025, 47.5992705 ], [ -122.336024, 47.5991681 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953587, "project_id": 13, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3359854, 47.5991046 ], [ -122.3358342, 47.599107 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953588, "project_id": 13, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360232, 47.5991529 ], [ -122.336024, 47.5991681 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953589, "project_id": 13, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336026, 47.5991027 ], [ -122.3359854, 47.5991046 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953590, "project_id": 13, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.335811, 47.5993358 ], [ -122.3357984, 47.5993363 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953591, "project_id": 13, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3357984, 47.5993363 ], [ -122.335784, 47.5993359 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953592, "project_id": 13, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360388, 47.5994864 ], [ -122.3360296, 47.599336 ], [ -122.336027, 47.5992898 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953593, "project_id": 13, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3360296, 47.599336 ], [ -122.3359964, 47.5993392 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953594, "project_id": 13, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.336027, 47.5992898 ], [ -122.336025, 47.5992705 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953595, "project_id": 13, "task_id": 92 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3354658, 47.5992917 ], [ -122.3352705, 47.5992857 ] ] } }, +{ "type": "Feature", "properties": { "id": 1953596, "project_id": 13, "task_id": 94 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3355051, 47.5989302 ], [ -122.3355245, 47.5991032 ], [ -122.3354848, 47.5991238 ], [ -122.3354591, 47.5991305 ], [ -122.3352793, 47.599128 ] ] } }, +{ "type": "Feature", "properties": { "id": 1961589, "project_id": 13, "task_id": 460 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314334, 47.6017967 ], [ -122.3314466, 47.6017789 ] ] } }, +{ "type": "Feature", "properties": { "id": 1961590, "project_id": 13, "task_id": 460 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3314477, 47.6016669 ], [ -122.3314446, 47.6016526 ] ] } } +] +} diff --git a/tests/xnqm/inputs/p13_polygon.geojson b/tests/xnqm/inputs/p13_polygon.geojson new file mode 100755 index 0000000..7c04f4c --- /dev/null +++ b/tests/xnqm/inputs/p13_polygon.geojson @@ -0,0 +1,543 @@ +{ +"type": "FeatureCollection", +"name": "p13", +"crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:OGC:1.3:CRS84" } }, +"features": [ +{ "type": "Feature", "properties": { "pk": "13115", "project_id": 13, "task_id": 115, "numnodechanges": 143, "numwaychanges": 21 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331255, 47.600404 ], [ -122.331257, 47.599964 ], [ -122.331915, 47.599956 ], [ -122.331913, 47.600464 ], [ -122.331905, 47.600471 ], [ -122.33138, 47.600462 ], [ -122.331255, 47.600404 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13151", "project_id": 13, "task_id": 151, "numnodechanges": 145, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321965, 47.604448 ], [ -122.322394, 47.604057 ], [ -122.322743, 47.604889 ], [ -122.322573, 47.605046 ], [ -122.322231, 47.605085 ], [ -122.321965, 47.604448 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13405", "project_id": 13, "task_id": 405, "numnodechanges": 462, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324276, 47.606327 ], [ -122.324448, 47.606327 ], [ -122.324736, 47.606998 ], [ -122.32451, 47.607201 ], [ -122.324186, 47.60723 ], [ -122.323926, 47.60659 ], [ -122.324152, 47.606388 ], [ -122.324276, 47.606327 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "137", "project_id": 13, "task_id": 7, "numnodechanges": 81, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319322, 47.599652 ], [ -122.320023, 47.598768 ], [ -122.320332, 47.598766 ], [ -122.320331, 47.599883 ], [ -122.320097, 47.600019 ], [ -122.319614, 47.599806 ], [ -122.319322, 47.599652 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13370", "project_id": 13, "task_id": 370, "numnodechanges": 7, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328289, 47.604798 ], [ -122.328502, 47.605298 ], [ -122.328499, 47.605552 ], [ -122.328007, 47.605642 ], [ -122.32761, 47.604708 ], [ -122.327634, 47.604659 ], [ -122.327723, 47.604658 ], [ -122.328289, 47.604798 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13475", "project_id": 13, "task_id": 475, "numnodechanges": 10, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32765, 47.609029 ], [ -122.327945, 47.609731 ], [ -122.327279, 47.609686 ], [ -122.327033, 47.609098 ], [ -122.327194, 47.608954 ], [ -122.32765, 47.609029 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13407", "project_id": 13, "task_id": 407, "numnodechanges": 82, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323788, 47.606061 ], [ -122.32366, 47.605752 ], [ -122.323777, 47.605482 ], [ -122.323852, 47.605455 ], [ -122.32403, 47.605882 ], [ -122.323828, 47.606066 ], [ -122.323788, 47.606061 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1319", "project_id": 13, "task_id": 19, "numnodechanges": 42, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335268, 47.600763 ], [ -122.335135, 47.600471 ], [ -122.335186, 47.600383 ], [ -122.335789, 47.600403 ], [ -122.335961, 47.60058 ], [ -122.335818, 47.600689 ], [ -122.335268, 47.600763 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13272", "project_id": 13, "task_id": 272, "numnodechanges": 129, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323365, 47.602292 ], [ -122.323391, 47.602347 ], [ -122.323293, 47.602724 ], [ -122.322625, 47.602926 ], [ -122.322102, 47.602315 ], [ -122.323365, 47.602292 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13310", "project_id": 13, "task_id": 310, "numnodechanges": 40, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3298, 47.607941 ], [ -122.329457, 47.607978 ], [ -122.329261, 47.607503 ], [ -122.329951, 47.606903 ], [ -122.32999, 47.606922 ], [ -122.330246, 47.607529 ], [ -122.3298, 47.607941 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13511", "project_id": 13, "task_id": 511, "numnodechanges": 36, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33087, 47.601306 ], [ -122.330873, 47.600639 ], [ -122.331042, 47.600592 ], [ -122.331052, 47.601204 ], [ -122.331007, 47.601305 ], [ -122.330876, 47.601307 ], [ -122.33087, 47.601306 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13472", "project_id": 13, "task_id": 472, "numnodechanges": 5, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327553, 47.608461 ], [ -122.327335, 47.607945 ], [ -122.327615, 47.607819 ], [ -122.327918, 47.608539 ], [ -122.327553, 47.608461 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13173", "project_id": 13, "task_id": 173, "numnodechanges": 162, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32999, 47.606922 ], [ -122.329951, 47.606903 ], [ -122.329523, 47.606515 ], [ -122.329444, 47.606333 ], [ -122.329755, 47.605926 ], [ -122.330074, 47.605796 ], [ -122.330222, 47.605762 ], [ -122.330553, 47.606555 ], [ -122.32999, 47.606922 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13515", "project_id": 13, "task_id": 515, "numnodechanges": 87, "numwaychanges": 17 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334462, 47.603975 ], [ -122.334762, 47.603934 ], [ -122.334998, 47.604124 ], [ -122.334291, 47.604773 ], [ -122.3341, 47.604308 ], [ -122.334462, 47.603975 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1368", "project_id": 13, "task_id": 68, "numnodechanges": 53, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327865, 47.596025 ], [ -122.327877, 47.596006 ], [ -122.328695, 47.596009 ], [ -122.328329, 47.596827 ], [ -122.328243, 47.596898 ], [ -122.328153, 47.596872 ], [ -122.327865, 47.596025 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13238", "project_id": 13, "task_id": 238, "numnodechanges": 165, "numwaychanges": 26 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329958, 47.600579 ], [ -122.33046, 47.600582 ], [ -122.330561, 47.600687 ], [ -122.330558, 47.601056 ], [ -122.329961, 47.601049 ], [ -122.329958, 47.600579 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13439", "project_id": 13, "task_id": 439, "numnodechanges": 86, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336335, 47.603349 ], [ -122.336615, 47.604014 ], [ -122.336397, 47.604212 ], [ -122.336066, 47.604225 ], [ -122.335753, 47.6035 ], [ -122.335893, 47.603371 ], [ -122.336335, 47.603349 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13134", "project_id": 13, "task_id": 134, "numnodechanges": 108, "numwaychanges": 21 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32088, 47.603878 ], [ -122.32049, 47.603883 ], [ -122.320499, 47.603202 ], [ -122.321435, 47.603192 ], [ -122.321266, 47.603649 ], [ -122.32088, 47.603878 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13299", "project_id": 13, "task_id": 299, "numnodechanges": 147, "numwaychanges": 29 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336067, 47.605351 ], [ -122.336238, 47.605397 ], [ -122.336455, 47.605913 ], [ -122.336048, 47.606287 ], [ -122.335642, 47.606375 ], [ -122.335337, 47.606344 ], [ -122.335174, 47.605956 ], [ -122.335781, 47.605399 ], [ -122.336067, 47.605351 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13509", "project_id": 13, "task_id": 509, "numnodechanges": 45, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331007, 47.601305 ], [ -122.331058, 47.601343 ], [ -122.331056, 47.601971 ], [ -122.330872, 47.601911 ], [ -122.330876, 47.601307 ], [ -122.331007, 47.601305 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13194", "project_id": 13, "task_id": 194, "numnodechanges": 8, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321497, 47.599861 ], [ -122.321503, 47.598907 ], [ -122.321924, 47.59865 ], [ -122.322133, 47.598929 ], [ -122.322207, 47.599105 ], [ -122.322196, 47.600077 ], [ -122.321497, 47.599861 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13308", "project_id": 13, "task_id": 308, "numnodechanges": 104, "numwaychanges": 20 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329128, 47.609336 ], [ -122.329568, 47.608923 ], [ -122.329926, 47.608877 ], [ -122.330159, 47.609457 ], [ -122.329667, 47.60977 ], [ -122.329319, 47.609793 ], [ -122.329128, 47.609336 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13500", "project_id": 13, "task_id": 500, "numnodechanges": 1, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333776, 47.603254 ], [ -122.333456, 47.60291 ], [ -122.333293, 47.602536 ], [ -122.333572, 47.602272 ], [ -122.333712, 47.602254 ], [ -122.333904, 47.602401 ], [ -122.334172, 47.603035 ], [ -122.333936, 47.603241 ], [ -122.333776, 47.603254 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13159", "project_id": 13, "task_id": 159, "numnodechanges": 81, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321826, 47.606435 ], [ -122.32184, 47.606404 ], [ -122.3223, 47.606352 ], [ -122.322519, 47.606886 ], [ -122.322429, 47.607184 ], [ -122.322172, 47.607145 ], [ -122.321832, 47.606782 ], [ -122.321812, 47.606736 ], [ -122.321826, 47.606435 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13198", "project_id": 13, "task_id": 198, "numnodechanges": 171, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324733, 47.597097 ], [ -122.324736, 47.597095 ], [ -122.325383, 47.597099 ], [ -122.325381, 47.597943 ], [ -122.325378, 47.597945 ], [ -122.324878, 47.597942 ], [ -122.324731, 47.597725 ], [ -122.324733, 47.597097 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13140", "project_id": 13, "task_id": 140, "numnodechanges": 87, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322444, 47.603916 ], [ -122.322394, 47.604057 ], [ -122.321965, 47.604448 ], [ -122.321527, 47.604415 ], [ -122.321506, 47.604203 ], [ -122.322225, 47.603593 ], [ -122.322444, 47.603916 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13176", "project_id": 13, "task_id": 176, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332878, 47.606573 ], [ -122.333271, 47.606874 ], [ -122.333445, 47.607287 ], [ -122.333232, 47.607483 ], [ -122.333113, 47.607424 ], [ -122.332764, 47.606584 ], [ -122.332878, 47.606573 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1352", "project_id": 13, "task_id": 52, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320323, 47.606633 ], [ -122.320286, 47.606677 ], [ -122.320185, 47.606594 ], [ -122.319746, 47.606041 ], [ -122.319747, 47.605714 ], [ -122.320301, 47.605711 ], [ -122.320435, 47.606085 ], [ -122.320436, 47.606314 ], [ -122.320323, 47.606633 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1377", "project_id": 13, "task_id": 77, "numnodechanges": 1, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326833, 47.595728 ], [ -122.326906, 47.595565 ], [ -122.327016, 47.595536 ], [ -122.327222, 47.595764 ], [ -122.326853, 47.595763 ], [ -122.326833, 47.595728 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13311", "project_id": 13, "task_id": 311, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329926, 47.608877 ], [ -122.329568, 47.608923 ], [ -122.329249, 47.608168 ], [ -122.329457, 47.607978 ], [ -122.3298, 47.607941 ], [ -122.330118, 47.608695 ], [ -122.329926, 47.608877 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1391", "project_id": 13, "task_id": 91, "numnodechanges": 10, "numwaychanges": 1 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335779, 47.600168 ], [ -122.335789, 47.600403 ], [ -122.335186, 47.600383 ], [ -122.335251, 47.600143 ], [ -122.335779, 47.600168 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13180", "project_id": 13, "task_id": 180, "numnodechanges": 125, "numwaychanges": 14 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327865, 47.596025 ], [ -122.328153, 47.596872 ], [ -122.327649, 47.596869 ], [ -122.32734, 47.596098 ], [ -122.327382, 47.595985 ], [ -122.327865, 47.596025 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13516", "project_id": 13, "task_id": 516, "numnodechanges": 94, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333651, 47.604276 ], [ -122.333637, 47.604055 ], [ -122.334094, 47.603636 ], [ -122.334462, 47.603975 ], [ -122.3341, 47.604308 ], [ -122.333651, 47.604276 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13214", "project_id": 13, "task_id": 214, "numnodechanges": 9, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337014, 47.602048 ], [ -122.33679, 47.600854 ], [ -122.336971, 47.600543 ], [ -122.336975, 47.600539 ], [ -122.33742, 47.600437 ], [ -122.337423, 47.601725 ], [ -122.337054, 47.602061 ], [ -122.337014, 47.602048 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13259", "project_id": 13, "task_id": 259, "numnodechanges": 20, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332114, 47.606935 ], [ -122.332396, 47.607607 ], [ -122.332355, 47.607797 ], [ -122.332177, 47.6079 ], [ -122.331811, 47.607031 ], [ -122.332114, 47.606935 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13280", "project_id": 13, "task_id": 280, "numnodechanges": 339, "numwaychanges": 23 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322855, 47.60649 ], [ -122.322519, 47.606886 ], [ -122.3223, 47.606352 ], [ -122.322657, 47.606026 ], [ -122.322855, 47.60649 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13417", "project_id": 13, "task_id": 417, "numnodechanges": 42, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330883, 47.608408 ], [ -122.330321, 47.608669 ], [ -122.330118, 47.608695 ], [ -122.3298, 47.607941 ], [ -122.330246, 47.607529 ], [ -122.330594, 47.607661 ], [ -122.330892, 47.608383 ], [ -122.330883, 47.608408 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13142", "project_id": 13, "task_id": 142, "numnodechanges": 147, "numwaychanges": 26 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322018, 47.601945 ], [ -122.322015, 47.601366 ], [ -122.322796, 47.60063 ], [ -122.323261, 47.600975 ], [ -122.323256, 47.601947 ], [ -122.322018, 47.601945 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13249", "project_id": 13, "task_id": 249, "numnodechanges": 207, "numwaychanges": 26 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326696, 47.599897 ], [ -122.326694, 47.600458 ], [ -122.326031, 47.600458 ], [ -122.326033, 47.599613 ], [ -122.326037, 47.599611 ], [ -122.326584, 47.599614 ], [ -122.326696, 47.599897 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13412", "project_id": 13, "task_id": 412, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331823, 47.609222 ], [ -122.331899, 47.60887 ], [ -122.332335, 47.608477 ], [ -122.332694, 47.608601 ], [ -122.332099, 47.609138 ], [ -122.331823, 47.609222 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13431", "project_id": 13, "task_id": 431, "numnodechanges": 63, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332489, 47.601872 ], [ -122.332306, 47.601856 ], [ -122.332099, 47.601827 ], [ -122.332101, 47.601305 ], [ -122.332544, 47.601315 ], [ -122.332544, 47.601853 ], [ -122.332489, 47.601872 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13526", "project_id": 13, "task_id": 526, "numnodechanges": 225, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329067, 47.602049 ], [ -122.328883, 47.602181 ], [ -122.328583, 47.601635 ], [ -122.329022, 47.601631 ], [ -122.329067, 47.602049 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1328", "project_id": 13, "task_id": 28, "numnodechanges": 2, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33513, 47.596938 ], [ -122.335465, 47.596795 ], [ -122.336679, 47.597467 ], [ -122.336707, 47.59749 ], [ -122.335022, 47.597128 ], [ -122.33513, 47.596938 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13319", "project_id": 13, "task_id": 319, "numnodechanges": 214, "numwaychanges": 27 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323565, 47.596417 ], [ -122.324089, 47.596228 ], [ -122.324086, 47.597093 ], [ -122.324083, 47.597095 ], [ -122.323563, 47.597092 ], [ -122.323565, 47.596417 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13114", "project_id": 13, "task_id": 114, "numnodechanges": 18, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334513, 47.598935 ], [ -122.334555, 47.599044 ], [ -122.334554, 47.599327 ], [ -122.334187, 47.599325 ], [ -122.33419, 47.599116 ], [ -122.334513, 47.598935 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13177", "project_id": 13, "task_id": 177, "numnodechanges": 140, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332436, 47.605935 ], [ -122.332787, 47.605623 ], [ -122.333051, 47.605595 ], [ -122.33336, 47.605592 ], [ -122.333517, 47.605975 ], [ -122.332878, 47.606573 ], [ -122.332764, 47.606584 ], [ -122.332708, 47.606584 ], [ -122.332436, 47.605935 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13415", "project_id": 13, "task_id": 415, "numnodechanges": 10, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332694, 47.608601 ], [ -122.332773, 47.608613 ], [ -122.332759, 47.608844 ], [ -122.332475, 47.6091 ], [ -122.332099, 47.609138 ], [ -122.332694, 47.608601 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13255", "project_id": 13, "task_id": 255, "numnodechanges": 10, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326039, 47.598783 ], [ -122.325375, 47.598778 ], [ -122.325378, 47.597945 ], [ -122.325381, 47.597943 ], [ -122.326045, 47.597947 ], [ -122.326042, 47.59878 ], [ -122.326039, 47.598783 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13178", "project_id": 13, "task_id": 178, "numnodechanges": 0, "numwaychanges": 0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326852, 47.595896 ], [ -122.326853, 47.595763 ], [ -122.327222, 47.595764 ], [ -122.327364, 47.59584 ], [ -122.327366, 47.595897 ], [ -122.326852, 47.595896 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13290", "project_id": 13, "task_id": 290, "numnodechanges": 90, "numwaychanges": 12 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32356, 47.607202 ], [ -122.323296, 47.607443 ], [ -122.323104, 47.606971 ], [ -122.32336, 47.606736 ], [ -122.32356, 47.607202 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13384", "project_id": 13, "task_id": 384, "numnodechanges": 107, "numwaychanges": 16 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332525, 47.605211 ], [ -122.332008, 47.605668 ], [ -122.331924, 47.60547 ], [ -122.332431, 47.604983 ], [ -122.332525, 47.605211 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1333", "project_id": 13, "task_id": 33, "numnodechanges": 19, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334195, 47.598534 ], [ -122.334196, 47.598136 ], [ -122.334584, 47.597988 ], [ -122.334578, 47.598642 ], [ -122.334575, 47.598646 ], [ -122.334195, 47.598534 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "135", "project_id": 13, "task_id": 5, "numnodechanges": 115, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320097, 47.600019 ], [ -122.319967, 47.600328 ], [ -122.318774, 47.600747 ], [ -122.318939, 47.600381 ], [ -122.319614, 47.599806 ], [ -122.320097, 47.600019 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13126", "project_id": 13, "task_id": 126, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328099, 47.606475 ], [ -122.327768, 47.606775 ], [ -122.327606, 47.606793 ], [ -122.327289, 47.606031 ], [ -122.327506, 47.605839 ], [ -122.327818, 47.605802 ], [ -122.328099, 47.606475 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13480", "project_id": 13, "task_id": 480, "numnodechanges": 12, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331385, 47.607255 ], [ -122.331007, 47.606354 ], [ -122.331042, 47.606321 ], [ -122.331084, 47.606318 ], [ -122.331505, 47.606585 ], [ -122.331695, 47.60704 ], [ -122.331455, 47.607249 ], [ -122.331385, 47.607255 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13138", "project_id": 13, "task_id": 138, "numnodechanges": 125, "numwaychanges": 17 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318992, 47.603175 ], [ -122.318509, 47.603468 ], [ -122.318402, 47.602736 ], [ -122.318987, 47.602157 ], [ -122.318992, 47.603175 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13106", "project_id": 13, "task_id": 106, "numnodechanges": 58, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331961, 47.599779 ], [ -122.331915, 47.599956 ], [ -122.331257, 47.599964 ], [ -122.33121, 47.599789 ], [ -122.331961, 47.599779 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13312", "project_id": 13, "task_id": 312, "numnodechanges": 19, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330321, 47.608669 ], [ -122.330585, 47.609324 ], [ -122.330343, 47.609531 ], [ -122.330159, 47.609457 ], [ -122.329926, 47.608877 ], [ -122.330118, 47.608695 ], [ -122.330321, 47.608669 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13354", "project_id": 13, "task_id": 354, "numnodechanges": 110, "numwaychanges": 16 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333293, 47.602536 ], [ -122.333456, 47.60291 ], [ -122.332981, 47.603346 ], [ -122.332798, 47.6029 ], [ -122.333189, 47.602548 ], [ -122.333293, 47.602536 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13121", "project_id": 13, "task_id": 121, "numnodechanges": 34, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330608, 47.598969 ], [ -122.330725, 47.598758 ], [ -122.331059, 47.598606 ], [ -122.331255, 47.598748 ], [ -122.331253, 47.599457 ], [ -122.331123, 47.599628 ], [ -122.330697, 47.599625 ], [ -122.330609, 47.599538 ], [ -122.330606, 47.599534 ], [ -122.330608, 47.598969 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13163", "project_id": 13, "task_id": 163, "numnodechanges": 48, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321016, 47.607277 ], [ -122.320286, 47.606677 ], [ -122.320323, 47.606633 ], [ -122.32094, 47.606639 ], [ -122.321072, 47.607024 ], [ -122.321016, 47.607277 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13321", "project_id": 13, "task_id": 321, "numnodechanges": 6, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324722, 47.598779 ], [ -122.324096, 47.598775 ], [ -122.324075, 47.598756 ], [ -122.324077, 47.598143 ], [ -122.324727, 47.598159 ], [ -122.324725, 47.598777 ], [ -122.324722, 47.598779 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13164", "project_id": 13, "task_id": 164, "numnodechanges": 0, "numwaychanges": 0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326027, 47.609106 ], [ -122.326488, 47.609317 ], [ -122.326484, 47.609343 ], [ -122.326289, 47.609521 ], [ -122.325699, 47.609401 ], [ -122.326027, 47.609106 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13444", "project_id": 13, "task_id": 444, "numnodechanges": 2, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326708, 47.601318 ], [ -122.326691, 47.601304 ], [ -122.326697, 47.60046 ], [ -122.327254, 47.600463 ], [ -122.327344, 47.600804 ], [ -122.327352, 47.601287 ], [ -122.326708, 47.601318 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13215", "project_id": 13, "task_id": 215, "numnodechanges": 59, "numwaychanges": 20 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336702, 47.604001 ], [ -122.336615, 47.604014 ], [ -122.336335, 47.603349 ], [ -122.336709, 47.602998 ], [ -122.336985, 47.603046 ], [ -122.337197, 47.603551 ], [ -122.336702, 47.604001 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13197", "project_id": 13, "task_id": 197, "numnodechanges": 123, "numwaychanges": 26 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322779, 47.597937 ], [ -122.321952, 47.597932 ], [ -122.321546, 47.597453 ], [ -122.322543, 47.596901 ], [ -122.322782, 47.597089 ], [ -122.322779, 47.597937 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13534", "project_id": 13, "task_id": 534, "numnodechanges": 202, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329079, 47.604134 ], [ -122.328823, 47.603514 ], [ -122.329134, 47.603231 ], [ -122.329515, 47.603187 ], [ -122.329754, 47.6035 ], [ -122.329079, 47.604134 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13235", "project_id": 13, "task_id": 235, "numnodechanges": 13, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329921, 47.599885 ], [ -122.330322, 47.599517 ], [ -122.330606, 47.599534 ], [ -122.330609, 47.599538 ], [ -122.330158, 47.599936 ], [ -122.329956, 47.599982 ], [ -122.329921, 47.599885 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13455", "project_id": 13, "task_id": 455, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328425, 47.600985 ], [ -122.328433, 47.600456 ], [ -122.328637, 47.600404 ], [ -122.328774, 47.600799 ], [ -122.328772, 47.60098 ], [ -122.328425, 47.600985 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13196", "project_id": 13, "task_id": 196, "numnodechanges": 172, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322779, 47.598608 ], [ -122.32195, 47.598598 ], [ -122.321952, 47.597932 ], [ -122.322779, 47.597937 ], [ -122.322781, 47.597939 ], [ -122.322779, 47.598608 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13327", "project_id": 13, "task_id": 327, "numnodechanges": 267, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325372, 47.598781 ], [ -122.32537, 47.599443 ], [ -122.32472, 47.599439 ], [ -122.324722, 47.598779 ], [ -122.324725, 47.598777 ], [ -122.325372, 47.598781 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13531", "project_id": 13, "task_id": 531, "numnodechanges": 28, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33027, 47.60242 ], [ -122.330236, 47.602333 ], [ -122.330551, 47.601884 ], [ -122.330872, 47.601911 ], [ -122.331056, 47.601971 ], [ -122.331308, 47.602249 ], [ -122.330749, 47.602757 ], [ -122.330657, 47.602716 ], [ -122.33027, 47.60242 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13462", "project_id": 13, "task_id": 462, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328559, 47.599643 ], [ -122.32822, 47.599598 ], [ -122.328223, 47.598692 ], [ -122.328287, 47.598579 ], [ -122.328358, 47.598514 ], [ -122.328513, 47.598641 ], [ -122.328728, 47.599035 ], [ -122.328727, 47.599229 ], [ -122.328705, 47.599457 ], [ -122.328559, 47.599643 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1372", "project_id": 13, "task_id": 72, "numnodechanges": 29, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328695, 47.596009 ], [ -122.327877, 47.596006 ], [ -122.328079, 47.595418 ], [ -122.329076, 47.595352 ], [ -122.328695, 47.596009 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13157", "project_id": 13, "task_id": 157, "numnodechanges": 9, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324186, 47.60723 ], [ -122.32451, 47.607201 ], [ -122.324886, 47.608104 ], [ -122.324799, 47.608114 ], [ -122.324231, 47.608012 ], [ -122.323999, 47.607452 ], [ -122.324014, 47.607376 ], [ -122.324186, 47.60723 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13201", "project_id": 13, "task_id": 201, "numnodechanges": 106, "numwaychanges": 19 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335791, 47.600154 ], [ -122.335779, 47.600168 ], [ -122.335251, 47.600143 ], [ -122.335249, 47.59965 ], [ -122.335273, 47.599627 ], [ -122.335452, 47.59963 ], [ -122.335789, 47.599916 ], [ -122.335791, 47.600154 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13315", "project_id": 13, "task_id": 315, "numnodechanges": 299, "numwaychanges": 23 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323563, 47.597092 ], [ -122.324083, 47.597095 ], [ -122.324081, 47.597732 ], [ -122.323952, 47.59794 ], [ -122.323428, 47.597937 ], [ -122.323426, 47.597936 ], [ -122.323429, 47.59715 ], [ -122.323563, 47.597092 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13460", "project_id": 13, "task_id": 460, "numnodechanges": 117, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331056, 47.601971 ], [ -122.331058, 47.601343 ], [ -122.331587, 47.601506 ], [ -122.331585, 47.60213 ], [ -122.331502, 47.602207 ], [ -122.331308, 47.602249 ], [ -122.331056, 47.601971 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "134", "project_id": 13, "task_id": 4, "numnodechanges": 24, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329895, 47.597686 ], [ -122.32836, 47.597705 ], [ -122.328358, 47.597347 ], [ -122.330067, 47.597358 ], [ -122.329895, 47.597686 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13113", "project_id": 13, "task_id": 113, "numnodechanges": 4, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33384, 47.598536 ], [ -122.333841, 47.598535 ], [ -122.334195, 47.598534 ], [ -122.334575, 47.598646 ], [ -122.33451, 47.598884 ], [ -122.333841, 47.598887 ], [ -122.33384, 47.598536 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13100", "project_id": 13, "task_id": 100, "numnodechanges": 132, "numwaychanges": 26 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336455, 47.605913 ], [ -122.336874, 47.606075 ], [ -122.336969, 47.606303 ], [ -122.336307, 47.606911 ], [ -122.336048, 47.606287 ], [ -122.336455, 47.605913 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13208", "project_id": 13, "task_id": 208, "numnodechanges": 16, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33419, 47.599116 ], [ -122.334187, 47.599325 ], [ -122.33398, 47.599435 ], [ -122.33396, 47.599116 ], [ -122.33419, 47.599116 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13448", "project_id": 13, "task_id": 448, "numnodechanges": 9, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326569, 47.603794 ], [ -122.326372, 47.603792 ], [ -122.325985, 47.60332 ], [ -122.327287, 47.602417 ], [ -122.327618, 47.602835 ], [ -122.326569, 47.603794 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1327", "project_id": 13, "task_id": 27, "numnodechanges": 16, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336755, 47.597529 ], [ -122.336803, 47.597569 ], [ -122.336301, 47.597757 ], [ -122.335112, 47.597829 ], [ -122.334956, 47.597652 ], [ -122.336755, 47.597529 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13345", "project_id": 13, "task_id": 345, "numnodechanges": 17, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337788, 47.60184 ], [ -122.337785, 47.60027 ], [ -122.33841, 47.599913 ], [ -122.338408, 47.601737 ], [ -122.338226, 47.602022 ], [ -122.337788, 47.60184 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13382", "project_id": 13, "task_id": 382, "numnodechanges": 158, "numwaychanges": 16 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331587, 47.601506 ], [ -122.331827, 47.601279 ], [ -122.331901, 47.601243 ], [ -122.332101, 47.601305 ], [ -122.332099, 47.601827 ], [ -122.331775, 47.602133 ], [ -122.331585, 47.60213 ], [ -122.331587, 47.601506 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13123", "project_id": 13, "task_id": 123, "numnodechanges": 50, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325497, 47.60087 ], [ -122.325363, 47.60087 ], [ -122.325366, 47.599935 ], [ -122.325413, 47.599768 ], [ -122.325492, 47.59961 ], [ -122.326033, 47.599613 ], [ -122.326031, 47.600458 ], [ -122.325497, 47.60087 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13306", "project_id": 13, "task_id": 306, "numnodechanges": 132, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326934, 47.608154 ], [ -122.326487, 47.608208 ], [ -122.326255, 47.60817 ], [ -122.326043, 47.607664 ], [ -122.326339, 47.607392 ], [ -122.32681, 47.607123 ], [ -122.326813, 47.607124 ], [ -122.327151, 47.607958 ], [ -122.326934, 47.608154 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13488", "project_id": 13, "task_id": 488, "numnodechanges": 42, "numwaychanges": 14 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337725, 47.603097 ], [ -122.337226, 47.603563 ], [ -122.337197, 47.603551 ], [ -122.336985, 47.603046 ], [ -122.337462, 47.60261 ], [ -122.337538, 47.602622 ], [ -122.337725, 47.603097 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13479", "project_id": 13, "task_id": 479, "numnodechanges": 0, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331075, 47.607319 ], [ -122.330748, 47.606538 ], [ -122.331007, 47.606354 ], [ -122.331385, 47.607255 ], [ -122.331102, 47.607317 ], [ -122.331075, 47.607319 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1349", "project_id": 13, "task_id": 49, "numnodechanges": 225, "numwaychanges": 28 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320435, 47.606085 ], [ -122.321118, 47.606079 ], [ -122.321106, 47.606346 ], [ -122.321092, 47.606357 ], [ -122.320436, 47.606314 ], [ -122.320435, 47.606085 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1374", "project_id": 13, "task_id": 74, "numnodechanges": 1, "numwaychanges": 1 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326906, 47.595565 ], [ -122.326864, 47.595519 ], [ -122.327008, 47.595489 ], [ -122.327041, 47.595487 ], [ -122.327016, 47.595536 ], [ -122.326906, 47.595565 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13453", "project_id": 13, "task_id": 453, "numnodechanges": 26, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328637, 47.600404 ], [ -122.328668, 47.600373 ], [ -122.329067, 47.600376 ], [ -122.32937, 47.600426 ], [ -122.329211, 47.600798 ], [ -122.328774, 47.600799 ], [ -122.328637, 47.600404 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13289", "project_id": 13, "task_id": 289, "numnodechanges": 46, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3238, 47.608395 ], [ -122.32372, 47.60861 ], [ -122.323713, 47.608609 ], [ -122.323047, 47.608104 ], [ -122.322935, 47.607825 ], [ -122.322937, 47.607785 ], [ -122.323081, 47.607732 ], [ -122.323551, 47.6078 ], [ -122.3238, 47.608395 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13207", "project_id": 13, "task_id": 207, "numnodechanges": 5, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33396, 47.599116 ], [ -122.33398, 47.599435 ], [ -122.333872, 47.599686 ], [ -122.333839, 47.599699 ], [ -122.333699, 47.599654 ], [ -122.333673, 47.599212 ], [ -122.333748, 47.598961 ], [ -122.333826, 47.598921 ], [ -122.33396, 47.599116 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13413", "project_id": 13, "task_id": 413, "numnodechanges": 6, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332335, 47.608477 ], [ -122.332119, 47.607964 ], [ -122.332121, 47.607952 ], [ -122.332177, 47.6079 ], [ -122.332355, 47.607797 ], [ -122.332758, 47.60792 ], [ -122.332986, 47.608459 ], [ -122.332937, 47.608502 ], [ -122.332773, 47.608613 ], [ -122.332694, 47.608601 ], [ -122.332335, 47.608477 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13293", "project_id": 13, "task_id": 293, "numnodechanges": 4, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323104, 47.606971 ], [ -122.322554, 47.607303 ], [ -122.322429, 47.607184 ], [ -122.322519, 47.606886 ], [ -122.322855, 47.60649 ], [ -122.323374, 47.606657 ], [ -122.32336, 47.606736 ], [ -122.323104, 47.606971 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1326", "project_id": 13, "task_id": 26, "numnodechanges": 10, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333346, 47.597269 ], [ -122.333077, 47.59709 ], [ -122.332906, 47.596937 ], [ -122.332895, 47.596885 ], [ -122.334485, 47.596569 ], [ -122.3349, 47.597224 ], [ -122.334781, 47.597438 ], [ -122.333346, 47.597269 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13481", "project_id": 13, "task_id": 481, "numnodechanges": 44, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331179, 47.608284 ], [ -122.330892, 47.608383 ], [ -122.330594, 47.607661 ], [ -122.331075, 47.607319 ], [ -122.331102, 47.607317 ], [ -122.331369, 47.607982 ], [ -122.331179, 47.608284 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13339", "project_id": 13, "task_id": 339, "numnodechanges": 40, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334183, 47.600473 ], [ -122.334184, 47.601142 ], [ -122.333834, 47.601141 ], [ -122.333833, 47.600474 ], [ -122.333837, 47.600471 ], [ -122.334183, 47.600473 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13300", "project_id": 13, "task_id": 300, "numnodechanges": 126, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335174, 47.605956 ], [ -122.335337, 47.606344 ], [ -122.335285, 47.606439 ], [ -122.334885, 47.606796 ], [ -122.334554, 47.606823 ], [ -122.334245, 47.606087 ], [ -122.334468, 47.605878 ], [ -122.334973, 47.605829 ], [ -122.335174, 47.605956 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1378", "project_id": 13, "task_id": 78, "numnodechanges": 133, "numwaychanges": 23 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326065, 47.595682 ], [ -122.32649, 47.595595 ], [ -122.326548, 47.595674 ], [ -122.326547, 47.596011 ], [ -122.326064, 47.59601 ], [ -122.326065, 47.595682 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13326", "project_id": 13, "task_id": 326, "numnodechanges": 154, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324727, 47.598159 ], [ -122.324878, 47.597942 ], [ -122.325378, 47.597945 ], [ -122.325375, 47.598778 ], [ -122.325372, 47.598781 ], [ -122.324725, 47.598777 ], [ -122.324727, 47.598159 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "132", "project_id": 13, "task_id": 2, "numnodechanges": 124, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319371, 47.605568 ], [ -122.319194, 47.605345 ], [ -122.31894, 47.60478 ], [ -122.319373, 47.604791 ], [ -122.319371, 47.605568 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13404", "project_id": 13, "task_id": 404, "numnodechanges": 222, "numwaychanges": 20 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32346, 47.606354 ], [ -122.323333, 47.606052 ], [ -122.32366, 47.605752 ], [ -122.323788, 47.606061 ], [ -122.32346, 47.606354 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13418", "project_id": 13, "task_id": 418, "numnodechanges": 24, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331179, 47.608284 ], [ -122.331337, 47.608306 ], [ -122.331682, 47.608373 ], [ -122.331899, 47.60887 ], [ -122.331823, 47.609222 ], [ -122.331618, 47.609537 ], [ -122.331232, 47.609205 ], [ -122.330883, 47.608408 ], [ -122.330892, 47.608383 ], [ -122.331179, 47.608284 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13351", "project_id": 13, "task_id": 351, "numnodechanges": 33, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337251, 47.604723 ], [ -122.337028, 47.604917 ], [ -122.336698, 47.604934 ], [ -122.336397, 47.604212 ], [ -122.336615, 47.604014 ], [ -122.336702, 47.604001 ], [ -122.337078, 47.604301 ], [ -122.337251, 47.604723 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13250", "project_id": 13, "task_id": 250, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326037, 47.599611 ], [ -122.326033, 47.599613 ], [ -122.325492, 47.59961 ], [ -122.32537, 47.599443 ], [ -122.325372, 47.598781 ], [ -122.325375, 47.598778 ], [ -122.326039, 47.598783 ], [ -122.326037, 47.599611 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13522", "project_id": 13, "task_id": 522, "numnodechanges": 49, "numwaychanges": 15 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330135, 47.601472 ], [ -122.330555, 47.60147 ], [ -122.330551, 47.601884 ], [ -122.330236, 47.602333 ], [ -122.330135, 47.602255 ], [ -122.330135, 47.601472 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13381", "project_id": 13, "task_id": 381, "numnodechanges": 5, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328728, 47.599035 ], [ -122.328513, 47.598641 ], [ -122.328975, 47.598663 ], [ -122.329275, 47.598961 ], [ -122.329099, 47.599043 ], [ -122.328728, 47.599035 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13129", "project_id": 13, "task_id": 129, "numnodechanges": 282, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333372, 47.605567 ], [ -122.332982, 47.604615 ], [ -122.333157, 47.604452 ], [ -122.333498, 47.604413 ], [ -122.33381, 47.605175 ], [ -122.333372, 47.605567 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13128", "project_id": 13, "task_id": 128, "numnodechanges": 94, "numwaychanges": 17 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328499, 47.605552 ], [ -122.328582, 47.605614 ], [ -122.328782, 47.605836 ], [ -122.328913, 47.606135 ], [ -122.328529, 47.606475 ], [ -122.328099, 47.606475 ], [ -122.327818, 47.605802 ], [ -122.328007, 47.605642 ], [ -122.328499, 47.605552 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13141", "project_id": 13, "task_id": 141, "numnodechanges": 59, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323293, 47.602724 ], [ -122.323391, 47.602347 ], [ -122.324867, 47.602201 ], [ -122.325104, 47.602526 ], [ -122.323689, 47.603663 ], [ -122.323293, 47.602724 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13471", "project_id": 13, "task_id": 471, "numnodechanges": 4, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327553, 47.608461 ], [ -122.327918, 47.608539 ], [ -122.328066, 47.608643 ], [ -122.32765, 47.609029 ], [ -122.327194, 47.608954 ], [ -122.327198, 47.608787 ], [ -122.327553, 47.608461 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13301", "project_id": 13, "task_id": 301, "numnodechanges": 2, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333015, 47.608457 ], [ -122.333331, 47.609211 ], [ -122.333247, 47.609241 ], [ -122.332937, 47.608502 ], [ -122.332986, 47.608459 ], [ -122.333015, 47.608457 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13452", "project_id": 13, "task_id": 452, "numnodechanges": 144, "numwaychanges": 23 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328194, 47.602661 ], [ -122.328447, 47.602527 ], [ -122.328665, 47.602495 ], [ -122.328826, 47.602873 ], [ -122.328128, 47.603499 ], [ -122.328098, 47.603486 ], [ -122.327886, 47.602944 ], [ -122.328194, 47.602661 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13263", "project_id": 13, "task_id": 263, "numnodechanges": 305, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320771, 47.604408 ], [ -122.321021, 47.604405 ], [ -122.321266, 47.604585 ], [ -122.320921, 47.604903 ], [ -122.320429, 47.604902 ], [ -122.320359, 47.604821 ], [ -122.320771, 47.604408 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13136", "project_id": 13, "task_id": 136, "numnodechanges": 68, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319252, 47.603109 ], [ -122.319705, 47.603144 ], [ -122.319718, 47.603931 ], [ -122.319381, 47.603955 ], [ -122.318577, 47.60394 ], [ -122.318509, 47.603468 ], [ -122.318992, 47.603175 ], [ -122.319252, 47.603109 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13395", "project_id": 13, "task_id": 395, "numnodechanges": 194, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331042, 47.606321 ], [ -122.330809, 47.605761 ], [ -122.331236, 47.605375 ], [ -122.331485, 47.605956 ], [ -122.331084, 47.606318 ], [ -122.331042, 47.606321 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13369", "project_id": 13, "task_id": 369, "numnodechanges": 64, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327634, 47.604659 ], [ -122.327398, 47.604102 ], [ -122.328098, 47.603486 ], [ -122.328128, 47.603499 ], [ -122.328155, 47.603515 ], [ -122.328385, 47.604072 ], [ -122.327723, 47.604658 ], [ -122.327634, 47.604659 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13420", "project_id": 13, "task_id": 420, "numnodechanges": 1, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330748, 47.606538 ], [ -122.330553, 47.606555 ], [ -122.330222, 47.605762 ], [ -122.330356, 47.605646 ], [ -122.330809, 47.605761 ], [ -122.331042, 47.606321 ], [ -122.331007, 47.606354 ], [ -122.330748, 47.606538 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13376", "project_id": 13, "task_id": 376, "numnodechanges": 103, "numwaychanges": 16 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327597, 47.599419 ], [ -122.327329, 47.599588 ], [ -122.327232, 47.599512 ], [ -122.327233, 47.599198 ], [ -122.327323, 47.598898 ], [ -122.327496, 47.598986 ], [ -122.327597, 47.599419 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13396", "project_id": 13, "task_id": 396, "numnodechanges": 39, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32388, 47.60543 ], [ -122.32361, 47.604776 ], [ -122.32393, 47.604767 ], [ -122.32416, 47.605322 ], [ -122.32388, 47.60543 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13437", "project_id": 13, "task_id": 437, "numnodechanges": 50, "numwaychanges": 19 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335915, 47.602226 ], [ -122.336325, 47.602302 ], [ -122.336437, 47.602587 ], [ -122.335871, 47.603117 ], [ -122.335577, 47.602381 ], [ -122.335915, 47.602226 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1345", "project_id": 13, "task_id": 45, "numnodechanges": 27, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321158, 47.601358 ], [ -122.320885, 47.60122 ], [ -122.320891, 47.600802 ], [ -122.321357, 47.600795 ], [ -122.321351, 47.601279 ], [ -122.321158, 47.601358 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1348", "project_id": 13, "task_id": 48, "numnodechanges": 421, "numwaychanges": 27 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319967, 47.600328 ], [ -122.319994, 47.600841 ], [ -122.318562, 47.601324 ], [ -122.318585, 47.601168 ], [ -122.318774, 47.600747 ], [ -122.319967, 47.600328 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1364", "project_id": 13, "task_id": 64, "numnodechanges": 4, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323091, 47.59978 ], [ -122.323191, 47.599658 ], [ -122.323195, 47.599656 ], [ -122.324162, 47.599662 ], [ -122.324098, 47.599799 ], [ -122.323091, 47.59978 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1312", "project_id": 13, "task_id": 12, "numnodechanges": 111, "numwaychanges": 19 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328863, 47.607278 ], [ -122.328783, 47.60729 ], [ -122.32855, 47.606718 ], [ -122.328529, 47.606475 ], [ -122.328913, 47.606135 ], [ -122.329444, 47.606333 ], [ -122.329523, 47.606515 ], [ -122.328863, 47.607278 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13528", "project_id": 13, "task_id": 528, "numnodechanges": 20, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329022, 47.601631 ], [ -122.328583, 47.601635 ], [ -122.328531, 47.601575 ], [ -122.32863, 47.60147 ], [ -122.329411, 47.601464 ], [ -122.329414, 47.601561 ], [ -122.329022, 47.601631 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13122", "project_id": 13, "task_id": 122, "numnodechanges": 47, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330322, 47.599517 ], [ -122.329921, 47.599885 ], [ -122.329684, 47.599693 ], [ -122.330071, 47.599337 ], [ -122.330322, 47.599517 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1388", "project_id": 13, "task_id": 88, "numnodechanges": 171, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336287, 47.607268 ], [ -122.336485, 47.607407 ], [ -122.336617, 47.607725 ], [ -122.335809, 47.608172 ], [ -122.335534, 47.607509 ], [ -122.335672, 47.607383 ], [ -122.336013, 47.607267 ], [ -122.336287, 47.607268 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1384", "project_id": 13, "task_id": 84, "numnodechanges": 2, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321503, 47.598907 ], [ -122.320543, 47.598417 ], [ -122.320543, 47.598269 ], [ -122.321519, 47.597467 ], [ -122.321546, 47.597453 ], [ -122.321952, 47.597932 ], [ -122.32195, 47.598598 ], [ -122.321924, 47.59865 ], [ -122.321503, 47.598907 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13505", "project_id": 13, "task_id": 505, "numnodechanges": 399, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331308, 47.602249 ], [ -122.331502, 47.602207 ], [ -122.331847, 47.603033 ], [ -122.331536, 47.603316 ], [ -122.331051, 47.603246 ], [ -122.330916, 47.60316 ], [ -122.330749, 47.602757 ], [ -122.331308, 47.602249 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1334", "project_id": 13, "task_id": 34, "numnodechanges": 14, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329769, 47.598208 ], [ -122.329763, 47.598149 ], [ -122.329895, 47.597686 ], [ -122.330067, 47.597358 ], [ -122.33033, 47.597007 ], [ -122.331062, 47.597819 ], [ -122.331059, 47.598606 ], [ -122.330725, 47.598758 ], [ -122.329769, 47.598208 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13146", "project_id": 13, "task_id": 146, "numnodechanges": 248, "numwaychanges": 22 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325431, 47.604774 ], [ -122.326226, 47.604395 ], [ -122.326533, 47.605129 ], [ -122.326098, 47.605523 ], [ -122.325775, 47.605582 ], [ -122.325431, 47.604774 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13349", "project_id": 13, "task_id": 349, "numnodechanges": 98, "numwaychanges": 23 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337892, 47.604385 ], [ -122.338284, 47.604451 ], [ -122.338542, 47.605104 ], [ -122.33822, 47.605394 ], [ -122.337894, 47.605432 ], [ -122.337577, 47.604678 ], [ -122.337892, 47.604385 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13127", "project_id": 13, "task_id": 127, "numnodechanges": 52, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327506, 47.605839 ], [ -122.327289, 47.606031 ], [ -122.326949, 47.606064 ], [ -122.326558, 47.605139 ], [ -122.327184, 47.605077 ], [ -122.327506, 47.605839 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13399", "project_id": 13, "task_id": 399, "numnodechanges": 67, "numwaychanges": 22 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32393, 47.604767 ], [ -122.324492, 47.604251 ], [ -122.324715, 47.604413 ], [ -122.324858, 47.60473 ], [ -122.324813, 47.604856 ], [ -122.324316, 47.605308 ], [ -122.32416, 47.605322 ], [ -122.32393, 47.604767 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13414", "project_id": 13, "task_id": 414, "numnodechanges": 147, "numwaychanges": 27 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331682, 47.608373 ], [ -122.332119, 47.607964 ], [ -122.332335, 47.608477 ], [ -122.331899, 47.60887 ], [ -122.331682, 47.608373 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13356", "project_id": 13, "task_id": 356, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333005, 47.603551 ], [ -122.332837, 47.603709 ], [ -122.332495, 47.603745 ], [ -122.332191, 47.602994 ], [ -122.332351, 47.602846 ], [ -122.332798, 47.6029 ], [ -122.332981, 47.603346 ], [ -122.333005, 47.603551 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13313", "project_id": 13, "task_id": 313, "numnodechanges": 40, "numwaychanges": 14 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331232, 47.609205 ], [ -122.330585, 47.609324 ], [ -122.330321, 47.608669 ], [ -122.330883, 47.608408 ], [ -122.331232, 47.609205 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13179", "project_id": 13, "task_id": 179, "numnodechanges": 26, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327649, 47.596869 ], [ -122.327322, 47.597024 ], [ -122.326994, 47.596215 ], [ -122.32734, 47.596098 ], [ -122.327649, 47.596869 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13491", "project_id": 13, "task_id": 491, "numnodechanges": 29, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334178, 47.601565 ], [ -122.334178, 47.601936 ], [ -122.333861, 47.60202 ], [ -122.333863, 47.601562 ], [ -122.334178, 47.601565 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1394", "project_id": 13, "task_id": 94, "numnodechanges": 2, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335781, 47.598918 ], [ -122.335337, 47.598945 ], [ -122.335201, 47.598641 ], [ -122.335273, 47.598473 ], [ -122.335675, 47.598456 ], [ -122.335942, 47.598851 ], [ -122.335781, 47.598918 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13366", "project_id": 13, "task_id": 366, "numnodechanges": 62, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328385, 47.604072 ], [ -122.328744, 47.604392 ], [ -122.328289, 47.604798 ], [ -122.327723, 47.604658 ], [ -122.328385, 47.604072 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13498", "project_id": 13, "task_id": 498, "numnodechanges": 173, "numwaychanges": 19 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333429, 47.603573 ], [ -122.333776, 47.603254 ], [ -122.333936, 47.603241 ], [ -122.334094, 47.603636 ], [ -122.333637, 47.604055 ], [ -122.333429, 47.603573 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13213", "project_id": 13, "task_id": 213, "numnodechanges": 69, "numwaychanges": 27 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336452, 47.601165 ], [ -122.335813, 47.601105 ], [ -122.335818, 47.600689 ], [ -122.335961, 47.60058 ], [ -122.336971, 47.600543 ], [ -122.33679, 47.600854 ], [ -122.336472, 47.601157 ], [ -122.336452, 47.601165 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13365", "project_id": 13, "task_id": 365, "numnodechanges": 40, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329723, 47.604941 ], [ -122.330074, 47.605796 ], [ -122.329755, 47.605926 ], [ -122.329471, 47.605233 ], [ -122.329508, 47.604887 ], [ -122.32955, 47.604888 ], [ -122.329723, 47.604941 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13230", "project_id": 13, "task_id": 230, "numnodechanges": 7, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332749, 47.599208 ], [ -122.332746, 47.599792 ], [ -122.33238, 47.599628 ], [ -122.332444, 47.598979 ], [ -122.332566, 47.598889 ], [ -122.332674, 47.59895 ], [ -122.332749, 47.599208 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13154", "project_id": 13, "task_id": 154, "numnodechanges": 186, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323047, 47.608104 ], [ -122.322949, 47.608376 ], [ -122.322876, 47.608441 ], [ -122.322495, 47.608231 ], [ -122.322935, 47.607825 ], [ -122.323047, 47.608104 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13190", "project_id": 13, "task_id": 190, "numnodechanges": 0, "numwaychanges": 0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321367, 47.600759 ], [ -122.321357, 47.600795 ], [ -122.320891, 47.600802 ], [ -122.320794, 47.600009 ], [ -122.321167, 47.599969 ], [ -122.321367, 47.600759 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13171", "project_id": 13, "task_id": 171, "numnodechanges": 3, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328723, 47.607346 ], [ -122.328783, 47.60729 ], [ -122.328863, 47.607278 ], [ -122.329261, 47.607503 ], [ -122.329457, 47.607978 ], [ -122.329249, 47.608168 ], [ -122.329081, 47.608188 ], [ -122.328723, 47.607346 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13520", "project_id": 13, "task_id": 520, "numnodechanges": 2, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334291, 47.604773 ], [ -122.334316, 47.604984 ], [ -122.334152, 47.60514 ], [ -122.33381, 47.605175 ], [ -122.333498, 47.604413 ], [ -122.333651, 47.604276 ], [ -122.3341, 47.604308 ], [ -122.334291, 47.604773 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13344", "project_id": 13, "task_id": 344, "numnodechanges": 27, "numwaychanges": 16 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332551, 47.60131 ], [ -122.332555, 47.600471 ], [ -122.332895, 47.600221 ], [ -122.333203, 47.60047 ], [ -122.3332, 47.60131 ], [ -122.332551, 47.60131 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13506", "project_id": 13, "task_id": 506, "numnodechanges": 50, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330916, 47.60316 ], [ -122.331051, 47.603246 ], [ -122.331026, 47.603702 ], [ -122.330603, 47.604085 ], [ -122.330287, 47.60373 ], [ -122.330916, 47.60316 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13409", "project_id": 13, "task_id": 409, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334973, 47.605829 ], [ -122.334468, 47.605878 ], [ -122.334152, 47.60514 ], [ -122.334316, 47.604984 ], [ -122.334745, 47.605 ], [ -122.334957, 47.605496 ], [ -122.334973, 47.605829 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13477", "project_id": 13, "task_id": 477, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327194, 47.608954 ], [ -122.327033, 47.609098 ], [ -122.326853, 47.609115 ], [ -122.326487, 47.608208 ], [ -122.326934, 47.608154 ], [ -122.327198, 47.608787 ], [ -122.327194, 47.608954 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13402", "project_id": 13, "task_id": 402, "numnodechanges": 29, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323476, 47.606559 ], [ -122.323374, 47.606657 ], [ -122.322855, 47.60649 ], [ -122.322657, 47.606026 ], [ -122.322663, 47.605992 ], [ -122.322886, 47.605796 ], [ -122.322904, 47.605795 ], [ -122.323333, 47.606052 ], [ -122.32346, 47.606354 ], [ -122.323476, 47.606559 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13361", "project_id": 13, "task_id": 361, "numnodechanges": 7, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325543, 47.602786 ], [ -122.325423, 47.60274 ], [ -122.325104, 47.602526 ], [ -122.324867, 47.602201 ], [ -122.32487, 47.601069 ], [ -122.325363, 47.60087 ], [ -122.325497, 47.60087 ], [ -122.32603, 47.601294 ], [ -122.326028, 47.601975 ], [ -122.325543, 47.602786 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13199", "project_id": 13, "task_id": 199, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334361, 47.607001 ], [ -122.334554, 47.606823 ], [ -122.334885, 47.606796 ], [ -122.335201, 47.607537 ], [ -122.334985, 47.607727 ], [ -122.334687, 47.607767 ], [ -122.334361, 47.607001 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1340", "project_id": 13, "task_id": 40, "numnodechanges": 6, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332982, 47.604615 ], [ -122.333372, 47.605567 ], [ -122.33336, 47.605592 ], [ -122.333051, 47.605595 ], [ -122.332676, 47.604678 ], [ -122.332982, 47.604615 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1335", "project_id": 13, "task_id": 35, "numnodechanges": 3, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326708, 47.597949 ], [ -122.327032, 47.597696 ], [ -122.327361, 47.597949 ], [ -122.32736, 47.598572 ], [ -122.327243, 47.598756 ], [ -122.326705, 47.598753 ], [ -122.326708, 47.597949 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13443", "project_id": 13, "task_id": 443, "numnodechanges": 16, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325673, 47.602907 ], [ -122.325543, 47.602786 ], [ -122.326028, 47.601975 ], [ -122.326707, 47.601873 ], [ -122.32685, 47.602095 ], [ -122.325673, 47.602907 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13254", "project_id": 13, "task_id": 254, "numnodechanges": 180, "numwaychanges": 27 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326045, 47.597947 ], [ -122.326048, 47.597945 ], [ -122.326708, 47.597949 ], [ -122.326705, 47.598753 ], [ -122.326668, 47.598784 ], [ -122.326042, 47.59878 ], [ -122.326045, 47.597947 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13284", "project_id": 13, "task_id": 284, "numnodechanges": 190, "numwaychanges": 23 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322886, 47.605796 ], [ -122.322573, 47.605046 ], [ -122.322743, 47.604889 ], [ -122.323117, 47.604808 ], [ -122.323356, 47.605382 ], [ -122.322904, 47.605795 ], [ -122.322886, 47.605796 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13487", "project_id": 13, "task_id": 487, "numnodechanges": 52, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.338205, 47.602402 ], [ -122.338615, 47.6027 ], [ -122.338629, 47.602731 ], [ -122.338653, 47.603405 ], [ -122.338144, 47.603437 ], [ -122.337894, 47.602541 ], [ -122.338205, 47.602402 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13422", "project_id": 13, "task_id": 422, "numnodechanges": 0, "numwaychanges": 0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326579, 47.596311 ], [ -122.326718, 47.596173 ], [ -122.326754, 47.596172 ], [ -122.326847, 47.596221 ], [ -122.326909, 47.597131 ], [ -122.326826, 47.597104 ], [ -122.326547, 47.596589 ], [ -122.326551, 47.596459 ], [ -122.326579, 47.596311 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13221", "project_id": 13, "task_id": 221, "numnodechanges": 125, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331915, 47.598523 ], [ -122.33175, 47.598762 ], [ -122.331255, 47.598748 ], [ -122.331059, 47.598606 ], [ -122.331062, 47.597819 ], [ -122.331917, 47.59782 ], [ -122.331915, 47.598523 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1385", "project_id": 13, "task_id": 85, "numnodechanges": 7, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323548, 47.598753 ], [ -122.323544, 47.599197 ], [ -122.32349, 47.599385 ], [ -122.32331, 47.599563 ], [ -122.323195, 47.599656 ], [ -122.323191, 47.599658 ], [ -122.3232, 47.598762 ], [ -122.323426, 47.598692 ], [ -122.323548, 47.598753 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13323", "project_id": 13, "task_id": 323, "numnodechanges": 244, "numwaychanges": 27 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323548, 47.598753 ], [ -122.323426, 47.598692 ], [ -122.323428, 47.597937 ], [ -122.323952, 47.59794 ], [ -122.324077, 47.598143 ], [ -122.324075, 47.598756 ], [ -122.323548, 47.598753 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13148", "project_id": 13, "task_id": 148, "numnodechanges": 4, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326098, 47.605523 ], [ -122.326459, 47.606377 ], [ -122.32597, 47.606505 ], [ -122.325868, 47.606509 ], [ -122.325559, 47.60578 ], [ -122.325775, 47.605582 ], [ -122.326098, 47.605523 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "136", "project_id": 13, "task_id": 6, "numnodechanges": 185, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318939, 47.600381 ], [ -122.319195, 47.599812 ], [ -122.319322, 47.599652 ], [ -122.319614, 47.599806 ], [ -122.318939, 47.600381 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13330", "project_id": 13, "task_id": 330, "numnodechanges": 200, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333586, 47.607276 ], [ -122.333445, 47.607287 ], [ -122.333271, 47.606874 ], [ -122.333741, 47.606436 ], [ -122.334005, 47.607064 ], [ -122.333885, 47.607175 ], [ -122.333586, 47.607276 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13193", "project_id": 13, "task_id": 193, "numnodechanges": 18, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321167, 47.599969 ], [ -122.320794, 47.600009 ], [ -122.320331, 47.599883 ], [ -122.320332, 47.598766 ], [ -122.320543, 47.598417 ], [ -122.321503, 47.598907 ], [ -122.321497, 47.599861 ], [ -122.321167, 47.599969 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1383", "project_id": 13, "task_id": 83, "numnodechanges": 41, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32537, 47.599443 ], [ -122.325492, 47.59961 ], [ -122.325413, 47.599768 ], [ -122.324666, 47.599763 ], [ -122.324584, 47.599608 ], [ -122.32472, 47.599439 ], [ -122.32537, 47.599443 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13373", "project_id": 13, "task_id": 373, "numnodechanges": 92, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32736, 47.598572 ], [ -122.327361, 47.597949 ], [ -122.328296, 47.597955 ], [ -122.328377, 47.598176 ], [ -122.328358, 47.598514 ], [ -122.328287, 47.598579 ], [ -122.32736, 47.598572 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13331", "project_id": 13, "task_id": 331, "numnodechanges": 85, "numwaychanges": 14 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334069, 47.607056 ], [ -122.334361, 47.607001 ], [ -122.334687, 47.607767 ], [ -122.334458, 47.607956 ], [ -122.334069, 47.607056 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13233", "project_id": 13, "task_id": 233, "numnodechanges": 28, "numwaychanges": 15 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330685, 47.59967 ], [ -122.330684, 47.600154 ], [ -122.330543, 47.600281 ], [ -122.330359, 47.600161 ], [ -122.330359, 47.600022 ], [ -122.33038, 47.599938 ], [ -122.330685, 47.59967 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13294", "project_id": 13, "task_id": 294, "numnodechanges": 15, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325021, 47.608332 ], [ -122.325242, 47.608646 ], [ -122.325133, 47.608877 ], [ -122.324789, 47.609182 ], [ -122.324273, 47.608996 ], [ -122.325021, 47.608332 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13273", "project_id": 13, "task_id": 273, "numnodechanges": 178, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322132, 47.603374 ], [ -122.322225, 47.603593 ], [ -122.321506, 47.604203 ], [ -122.321266, 47.603649 ], [ -122.321435, 47.603192 ], [ -122.321496, 47.603135 ], [ -122.322132, 47.603374 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13340", "project_id": 13, "task_id": 340, "numnodechanges": 26, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333839, 47.599699 ], [ -122.333872, 47.599686 ], [ -122.334193, 47.599743 ], [ -122.334186, 47.600473 ], [ -122.334183, 47.600473 ], [ -122.333837, 47.600471 ], [ -122.333839, 47.599699 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13363", "project_id": 13, "task_id": 363, "numnodechanges": 1, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328582, 47.605614 ], [ -122.328499, 47.605552 ], [ -122.328502, 47.605298 ], [ -122.329266, 47.604615 ], [ -122.329267, 47.604616 ], [ -122.329459, 47.604846 ], [ -122.328582, 47.605614 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13464", "project_id": 13, "task_id": 464, "numnodechanges": 2, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329425, 47.599547 ], [ -122.329444, 47.599575 ], [ -122.329463, 47.599628 ], [ -122.329379, 47.599764 ], [ -122.329222, 47.599807 ], [ -122.328645, 47.599803 ], [ -122.328559, 47.599643 ], [ -122.328705, 47.599457 ], [ -122.329179, 47.59946 ], [ -122.329425, 47.599547 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1331", "project_id": 13, "task_id": 31, "numnodechanges": 162, "numwaychanges": 27 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335715, 47.598099 ], [ -122.336301, 47.597757 ], [ -122.336803, 47.597569 ], [ -122.337277, 47.597958 ], [ -122.336743, 47.59832 ], [ -122.335744, 47.598382 ], [ -122.335715, 47.598099 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1396", "project_id": 13, "task_id": 96, "numnodechanges": 89, "numwaychanges": 17 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.339627, 47.603903 ], [ -122.339614, 47.603989 ], [ -122.339196, 47.604917 ], [ -122.338917, 47.60517 ], [ -122.338542, 47.605104 ], [ -122.338284, 47.604451 ], [ -122.33902, 47.603784 ], [ -122.339627, 47.603903 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1399", "project_id": 13, "task_id": 99, "numnodechanges": 5, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334538, 47.601219 ], [ -122.334537, 47.600476 ], [ -122.334542, 47.600473 ], [ -122.335135, 47.600471 ], [ -122.335268, 47.600763 ], [ -122.335266, 47.601252 ], [ -122.3352, 47.601307 ], [ -122.334608, 47.601319 ], [ -122.334538, 47.601219 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13275", "project_id": 13, "task_id": 275, "numnodechanges": 366, "numwaychanges": 27 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321458, 47.602777 ], [ -122.320419, 47.602788 ], [ -122.320422, 47.602204 ], [ -122.321151, 47.602199 ], [ -122.321459, 47.602437 ], [ -122.321458, 47.602777 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13228", "project_id": 13, "task_id": 228, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333222, 47.599201 ], [ -122.333673, 47.599212 ], [ -122.333699, 47.599654 ], [ -122.333219, 47.59965 ], [ -122.33322, 47.599211 ], [ -122.333222, 47.599201 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1363", "project_id": 13, "task_id": 63, "numnodechanges": 20, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329261, 47.607503 ], [ -122.328863, 47.607278 ], [ -122.329523, 47.606515 ], [ -122.329951, 47.606903 ], [ -122.329261, 47.607503 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13104", "project_id": 13, "task_id": 104, "numnodechanges": 2, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332155, 47.598979 ], [ -122.332153, 47.599632 ], [ -122.332023, 47.599659 ], [ -122.331822, 47.59945 ], [ -122.331824, 47.598867 ], [ -122.332155, 47.598979 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13451", "project_id": 13, "task_id": 451, "numnodechanges": 134, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328098, 47.603486 ], [ -122.327398, 47.604102 ], [ -122.326569, 47.603794 ], [ -122.327618, 47.602835 ], [ -122.327886, 47.602944 ], [ -122.328098, 47.603486 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13490", "project_id": 13, "task_id": 490, "numnodechanges": 8, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333697, 47.601304 ], [ -122.333863, 47.601562 ], [ -122.333861, 47.60202 ], [ -122.333712, 47.602254 ], [ -122.333572, 47.602272 ], [ -122.333563, 47.602259 ], [ -122.333566, 47.601313 ], [ -122.333697, 47.601304 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1344", "project_id": 13, "task_id": 44, "numnodechanges": 326, "numwaychanges": 22 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321151, 47.602199 ], [ -122.320422, 47.602204 ], [ -122.320168, 47.602029 ], [ -122.320173, 47.601367 ], [ -122.320885, 47.60122 ], [ -122.321158, 47.601358 ], [ -122.321151, 47.602199 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13251", "project_id": 13, "task_id": 251, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326705, 47.598753 ], [ -122.327243, 47.598756 ], [ -122.327323, 47.598898 ], [ -122.327233, 47.599198 ], [ -122.326704, 47.599195 ], [ -122.326668, 47.598784 ], [ -122.326705, 47.598753 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13364", "project_id": 13, "task_id": 364, "numnodechanges": 3, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329471, 47.605233 ], [ -122.328782, 47.605836 ], [ -122.328582, 47.605614 ], [ -122.329459, 47.604846 ], [ -122.329508, 47.604887 ], [ -122.329471, 47.605233 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13495", "project_id": 13, "task_id": 495, "numnodechanges": 65, "numwaychanges": 16 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333563, 47.602259 ], [ -122.333198, 47.601773 ], [ -122.3332, 47.601311 ], [ -122.333566, 47.601313 ], [ -122.333563, 47.602259 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13260", "project_id": 13, "task_id": 260, "numnodechanges": 225, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332528, 47.606768 ], [ -122.332748, 47.60729 ], [ -122.332396, 47.607607 ], [ -122.332114, 47.606935 ], [ -122.332186, 47.606871 ], [ -122.332528, 47.606768 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13132", "project_id": 13, "task_id": 132, "numnodechanges": 73, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320132, 47.603949 ], [ -122.319741, 47.603949 ], [ -122.319718, 47.603931 ], [ -122.319705, 47.603144 ], [ -122.319745, 47.603114 ], [ -122.320143, 47.603116 ], [ -122.320132, 47.603949 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1336", "project_id": 13, "task_id": 36, "numnodechanges": 307, "numwaychanges": 19 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331026, 47.603702 ], [ -122.331118, 47.603925 ], [ -122.3307, 47.604317 ], [ -122.330603, 47.604085 ], [ -122.331026, 47.603702 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13470", "project_id": 13, "task_id": 470, "numnodechanges": 217, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330784, 47.604616 ], [ -122.330733, 47.604575 ], [ -122.331303, 47.604038 ], [ -122.331734, 47.604096 ], [ -122.331721, 47.604168 ], [ -122.331369, 47.604503 ], [ -122.330784, 47.604616 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13389", "project_id": 13, "task_id": 389, "numnodechanges": 0, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331263, 47.605288 ], [ -122.331236, 47.605375 ], [ -122.330809, 47.605761 ], [ -122.330356, 47.605646 ], [ -122.330363, 47.60551 ], [ -122.330937, 47.604991 ], [ -122.331263, 47.605288 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1382", "project_id": 13, "task_id": 82, "numnodechanges": 31, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32559, 47.596257 ], [ -122.325591, 47.595779 ], [ -122.326065, 47.595682 ], [ -122.326064, 47.59601 ], [ -122.325948, 47.596234 ], [ -122.325855, 47.596261 ], [ -122.32559, 47.596257 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13355", "project_id": 13, "task_id": 355, "numnodechanges": 8, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332798, 47.6029 ], [ -122.332351, 47.602846 ], [ -122.332343, 47.602673 ], [ -122.332805, 47.602226 ], [ -122.333189, 47.602548 ], [ -122.332798, 47.6029 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13383", "project_id": 13, "task_id": 383, "numnodechanges": 31, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331007, 47.601305 ], [ -122.331052, 47.601204 ], [ -122.331378, 47.600913 ], [ -122.331827, 47.601279 ], [ -122.331587, 47.601506 ], [ -122.331058, 47.601343 ], [ -122.331007, 47.601305 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13397", "project_id": 13, "task_id": 397, "numnodechanges": 15, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323852, 47.605455 ], [ -122.323777, 47.605482 ], [ -122.323356, 47.605382 ], [ -122.323117, 47.604808 ], [ -122.323315, 47.604594 ], [ -122.32361, 47.604776 ], [ -122.32388, 47.60543 ], [ -122.323852, 47.605455 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13507", "project_id": 13, "task_id": 507, "numnodechanges": 8, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330287, 47.60373 ], [ -122.330603, 47.604085 ], [ -122.3307, 47.604317 ], [ -122.330731, 47.604575 ], [ -122.330564, 47.604621 ], [ -122.330099, 47.604379 ], [ -122.329937, 47.603986 ], [ -122.329997, 47.603728 ], [ -122.330287, 47.60373 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13447", "project_id": 13, "task_id": 447, "numnodechanges": 13, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327287, 47.602417 ], [ -122.325985, 47.60332 ], [ -122.325945, 47.603293 ], [ -122.325673, 47.602907 ], [ -122.32685, 47.602095 ], [ -122.327268, 47.602312 ], [ -122.327287, 47.602417 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1361", "project_id": 13, "task_id": 61, "numnodechanges": 22, "numwaychanges": 15 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326919, 47.606093 ], [ -122.326949, 47.606064 ], [ -122.327289, 47.606031 ], [ -122.327606, 47.606793 ], [ -122.327403, 47.606979 ], [ -122.327292, 47.606993 ], [ -122.326919, 47.606093 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1365", "project_id": 13, "task_id": 65, "numnodechanges": 4, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324065, 47.599947 ], [ -122.322904, 47.599955 ], [ -122.323091, 47.59978 ], [ -122.324098, 47.599799 ], [ -122.324065, 47.599947 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13421", "project_id": 13, "task_id": 421, "numnodechanges": 34, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326551, 47.596459 ], [ -122.326547, 47.596589 ], [ -122.326183, 47.596581 ], [ -122.326137, 47.596478 ], [ -122.326551, 47.596459 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13205", "project_id": 13, "task_id": 205, "numnodechanges": 19, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33454, 47.599742 ], [ -122.334542, 47.600473 ], [ -122.334537, 47.600476 ], [ -122.334186, 47.600473 ], [ -122.334193, 47.599743 ], [ -122.33454, 47.599742 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13474", "project_id": 13, "task_id": 474, "numnodechanges": 47, "numwaychanges": 19 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328425, 47.608608 ], [ -122.328463, 47.608623 ], [ -122.328686, 47.609164 ], [ -122.32807, 47.609739 ], [ -122.327945, 47.609731 ], [ -122.32765, 47.609029 ], [ -122.328066, 47.608643 ], [ -122.328425, 47.608608 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13517", "project_id": 13, "task_id": 517, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334462, 47.603975 ], [ -122.334094, 47.603636 ], [ -122.333936, 47.603241 ], [ -122.334172, 47.603035 ], [ -122.334502, 47.603015 ], [ -122.334776, 47.603684 ], [ -122.334762, 47.603934 ], [ -122.334462, 47.603975 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13170", "project_id": 13, "task_id": 170, "numnodechanges": 22, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328807, 47.608304 ], [ -122.328457, 47.60748 ], [ -122.328723, 47.607346 ], [ -122.329081, 47.608188 ], [ -122.328807, 47.608304 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1367", "project_id": 13, "task_id": 67, "numnodechanges": 10, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324162, 47.599662 ], [ -122.324197, 47.599606 ], [ -122.324584, 47.599608 ], [ -122.324666, 47.599763 ], [ -122.324716, 47.599931 ], [ -122.324713, 47.600975 ], [ -122.324063, 47.600831 ], [ -122.324065, 47.599947 ], [ -122.324098, 47.599799 ], [ -122.324162, 47.599662 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13493", "project_id": 13, "task_id": 493, "numnodechanges": 9, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333834, 47.601141 ], [ -122.334184, 47.601142 ], [ -122.334538, 47.601219 ], [ -122.334608, 47.601319 ], [ -122.334543, 47.601458 ], [ -122.334178, 47.601565 ], [ -122.333863, 47.601562 ], [ -122.333697, 47.601304 ], [ -122.333834, 47.601141 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13362", "project_id": 13, "task_id": 362, "numnodechanges": 152, "numwaychanges": 23 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329508, 47.604887 ], [ -122.329459, 47.604846 ], [ -122.329267, 47.604616 ], [ -122.329937, 47.603986 ], [ -122.330099, 47.604379 ], [ -122.32955, 47.604888 ], [ -122.329508, 47.604887 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13416", "project_id": 13, "task_id": 416, "numnodechanges": 3, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327151, 47.607958 ], [ -122.326813, 47.607124 ], [ -122.327292, 47.606993 ], [ -122.327403, 47.606979 ], [ -122.327715, 47.607729 ], [ -122.327615, 47.607819 ], [ -122.327335, 47.607945 ], [ -122.327151, 47.607958 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13502", "project_id": 13, "task_id": 502, "numnodechanges": 12, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329528, 47.600464 ], [ -122.329847, 47.600461 ], [ -122.329958, 47.600579 ], [ -122.329961, 47.601049 ], [ -122.329904, 47.601155 ], [ -122.329524, 47.601256 ], [ -122.329528, 47.600464 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13385", "project_id": 13, "task_id": 385, "numnodechanges": 6, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332434, 47.604837 ], [ -122.3326, 47.604685 ], [ -122.332676, 47.604678 ], [ -122.333051, 47.605595 ], [ -122.332787, 47.605623 ], [ -122.332525, 47.605211 ], [ -122.332431, 47.604983 ], [ -122.332434, 47.604837 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13187", "project_id": 13, "task_id": 187, "numnodechanges": 37, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322133, 47.598929 ], [ -122.321924, 47.59865 ], [ -122.32195, 47.598598 ], [ -122.322779, 47.598608 ], [ -122.322866, 47.598729 ], [ -122.322771, 47.598926 ], [ -122.322133, 47.598929 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1362", "project_id": 13, "task_id": 62, "numnodechanges": 16, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328261, 47.6075 ], [ -122.328104, 47.60713 ], [ -122.32855, 47.606718 ], [ -122.328783, 47.60729 ], [ -122.328723, 47.607346 ], [ -122.328457, 47.60748 ], [ -122.328261, 47.6075 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13143", "project_id": 13, "task_id": 143, "numnodechanges": 39, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323261, 47.600975 ], [ -122.324063, 47.600831 ], [ -122.324713, 47.600975 ], [ -122.32487, 47.601069 ], [ -122.324867, 47.602201 ], [ -122.323391, 47.602347 ], [ -122.323365, 47.602292 ], [ -122.323256, 47.601947 ], [ -122.323261, 47.600975 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13195", "project_id": 13, "task_id": 195, "numnodechanges": 80, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322207, 47.599105 ], [ -122.322731, 47.599105 ], [ -122.322832, 47.600011 ], [ -122.322653, 47.600293 ], [ -122.322282, 47.600131 ], [ -122.322196, 47.600077 ], [ -122.322207, 47.599105 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13211", "project_id": 13, "task_id": 211, "numnodechanges": 27, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33679, 47.600854 ], [ -122.337014, 47.602048 ], [ -122.336478, 47.602175 ], [ -122.336472, 47.601157 ], [ -122.33679, 47.600854 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1347", "project_id": 13, "task_id": 47, "numnodechanges": 60, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319994, 47.600841 ], [ -122.319967, 47.600328 ], [ -122.320097, 47.600019 ], [ -122.320331, 47.599883 ], [ -122.320794, 47.600009 ], [ -122.320891, 47.600802 ], [ -122.320885, 47.60122 ], [ -122.320173, 47.601367 ], [ -122.320138, 47.601326 ], [ -122.319994, 47.600841 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13162", "project_id": 13, "task_id": 162, "numnodechanges": 398, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32094, 47.606639 ], [ -122.321092, 47.606357 ], [ -122.321106, 47.606346 ], [ -122.321184, 47.60639 ], [ -122.32135, 47.60677 ], [ -122.321072, 47.607024 ], [ -122.32094, 47.606639 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13512", "project_id": 13, "task_id": 512, "numnodechanges": 178, "numwaychanges": 26 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335013, 47.602552 ], [ -122.335047, 47.602464 ], [ -122.335197, 47.602383 ], [ -122.335577, 47.602381 ], [ -122.335871, 47.603117 ], [ -122.335893, 47.603371 ], [ -122.335753, 47.6035 ], [ -122.33572, 47.603502 ], [ -122.335281, 47.603226 ], [ -122.335013, 47.602552 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13309", "project_id": 13, "task_id": 309, "numnodechanges": 80, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326484, 47.609343 ], [ -122.326488, 47.609317 ], [ -122.326572, 47.609239 ], [ -122.326853, 47.609115 ], [ -122.327033, 47.609098 ], [ -122.327279, 47.609686 ], [ -122.327008, 47.609668 ], [ -122.326583, 47.609582 ], [ -122.326484, 47.609343 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13274", "project_id": 13, "task_id": 274, "numnodechanges": 23, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321496, 47.603135 ], [ -122.321435, 47.603192 ], [ -122.320499, 47.603202 ], [ -122.320353, 47.60308 ], [ -122.320419, 47.602788 ], [ -122.321458, 47.602777 ], [ -122.321496, 47.603135 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13337", "project_id": 13, "task_id": 337, "numnodechanges": 48, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336284, 47.59964 ], [ -122.336075, 47.599489 ], [ -122.336105, 47.598843 ], [ -122.336248, 47.598759 ], [ -122.336383, 47.599234 ], [ -122.336284, 47.59964 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13152", "project_id": 13, "task_id": 152, "numnodechanges": 22, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321665, 47.605315 ], [ -122.32136, 47.604576 ], [ -122.321527, 47.604415 ], [ -122.321965, 47.604448 ], [ -122.322231, 47.605085 ], [ -122.32201, 47.605286 ], [ -122.321665, 47.605315 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13391", "project_id": 13, "task_id": 391, "numnodechanges": 0, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331084, 47.606318 ], [ -122.331485, 47.605956 ], [ -122.331951, 47.60598 ], [ -122.331912, 47.606216 ], [ -122.331505, 47.606585 ], [ -122.331084, 47.606318 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13186", "project_id": 13, "task_id": 186, "numnodechanges": 169, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322731, 47.599105 ], [ -122.322207, 47.599105 ], [ -122.322133, 47.598929 ], [ -122.322771, 47.598926 ], [ -122.322731, 47.599105 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13353", "project_id": 13, "task_id": 353, "numnodechanges": 108, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337653, 47.603812 ], [ -122.337892, 47.604385 ], [ -122.337577, 47.604678 ], [ -122.337251, 47.604723 ], [ -122.337078, 47.604301 ], [ -122.337624, 47.603803 ], [ -122.337653, 47.603812 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13237", "project_id": 13, "task_id": 237, "numnodechanges": 24, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329847, 47.600461 ], [ -122.329959, 47.60016 ], [ -122.330359, 47.600161 ], [ -122.330543, 47.600281 ], [ -122.33046, 47.600582 ], [ -122.329958, 47.600579 ], [ -122.329847, 47.600461 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1398", "project_id": 13, "task_id": 98, "numnodechanges": 15, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335422, 47.601281 ], [ -122.335813, 47.601105 ], [ -122.336452, 47.601165 ], [ -122.335893, 47.601685 ], [ -122.335422, 47.601281 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1356", "project_id": 13, "task_id": 56, "numnodechanges": 22, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325382, 47.607715 ], [ -122.325069, 47.606965 ], [ -122.325284, 47.606767 ], [ -122.325624, 47.60673 ], [ -122.326007, 47.60765 ], [ -122.325382, 47.607715 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13371", "project_id": 13, "task_id": 371, "numnodechanges": 2, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328645, 47.599803 ], [ -122.328669, 47.599994 ], [ -122.328668, 47.600373 ], [ -122.328637, 47.600404 ], [ -122.328433, 47.600456 ], [ -122.328072, 47.600454 ], [ -122.327995, 47.60038 ], [ -122.327997, 47.599839 ], [ -122.328121, 47.599635 ], [ -122.32822, 47.599598 ], [ -122.328559, 47.599643 ], [ -122.328645, 47.599803 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13248", "project_id": 13, "task_id": 248, "numnodechanges": 179, "numwaychanges": 28 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326668, 47.598784 ], [ -122.326704, 47.599195 ], [ -122.326676, 47.599508 ], [ -122.326584, 47.599614 ], [ -122.326037, 47.599611 ], [ -122.326039, 47.598783 ], [ -122.326042, 47.59878 ], [ -122.326668, 47.598784 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1323", "project_id": 13, "task_id": 23, "numnodechanges": 97, "numwaychanges": 19 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337669, 47.605631 ], [ -122.33798, 47.606376 ], [ -122.337527, 47.606788 ], [ -122.337266, 47.60669 ], [ -122.336969, 47.606303 ], [ -122.336874, 47.606075 ], [ -122.337338, 47.605654 ], [ -122.337669, 47.605631 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13424", "project_id": 13, "task_id": 424, "numnodechanges": 23, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326035, 47.596304 ], [ -122.326579, 47.596311 ], [ -122.326551, 47.596459 ], [ -122.326137, 47.596478 ], [ -122.326035, 47.596304 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1392", "project_id": 13, "task_id": 92, "numnodechanges": 7, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335249, 47.59965 ], [ -122.334657, 47.599631 ], [ -122.334554, 47.599327 ], [ -122.334555, 47.599044 ], [ -122.33527, 47.599153 ], [ -122.335273, 47.599627 ], [ -122.335249, 47.59965 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1397", "project_id": 13, "task_id": 97, "numnodechanges": 86, "numwaychanges": 19 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335266, 47.601252 ], [ -122.335268, 47.600763 ], [ -122.335818, 47.600689 ], [ -122.335813, 47.601105 ], [ -122.335422, 47.601281 ], [ -122.335266, 47.601252 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1315", "project_id": 13, "task_id": 15, "numnodechanges": 58, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324063, 47.600831 ], [ -122.323261, 47.600975 ], [ -122.322796, 47.60063 ], [ -122.322653, 47.600293 ], [ -122.322832, 47.600011 ], [ -122.322904, 47.599955 ], [ -122.324065, 47.599947 ], [ -122.324063, 47.600831 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13432", "project_id": 13, "task_id": 432, "numnodechanges": 46, "numwaychanges": 12 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.339796, 47.60274 ], [ -122.339627, 47.603903 ], [ -122.33902, 47.603784 ], [ -122.338653, 47.603405 ], [ -122.338629, 47.602731 ], [ -122.339796, 47.60274 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1310", "project_id": 13, "task_id": 10, "numnodechanges": 160, "numwaychanges": 21 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32487, 47.601069 ], [ -122.324713, 47.600975 ], [ -122.324716, 47.599931 ], [ -122.325366, 47.599935 ], [ -122.325363, 47.60087 ], [ -122.32487, 47.601069 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13302", "project_id": 13, "task_id": 302, "numnodechanges": 6, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333335, 47.608416 ], [ -122.333624, 47.609105 ], [ -122.333331, 47.609211 ], [ -122.333015, 47.608457 ], [ -122.333335, 47.608416 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1379", "project_id": 13, "task_id": 79, "numnodechanges": 3, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325852, 47.5971 ], [ -122.325386, 47.597097 ], [ -122.325389, 47.596325 ], [ -122.32559, 47.596257 ], [ -122.325855, 47.596261 ], [ -122.325852, 47.5971 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "131", "project_id": 13, "task_id": 1, "numnodechanges": 71, "numwaychanges": 16 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336485, 47.607407 ], [ -122.337266, 47.60669 ], [ -122.337527, 47.606788 ], [ -122.337591, 47.606942 ], [ -122.336681, 47.60769 ], [ -122.336617, 47.607725 ], [ -122.336485, 47.607407 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13124", "project_id": 13, "task_id": 124, "numnodechanges": 132, "numwaychanges": 26 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329444, 47.606333 ], [ -122.328913, 47.606135 ], [ -122.328782, 47.605836 ], [ -122.329471, 47.605233 ], [ -122.329755, 47.605926 ], [ -122.329444, 47.606333 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13149", "project_id": 13, "task_id": 149, "numnodechanges": 3, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322743, 47.604889 ], [ -122.322394, 47.604057 ], [ -122.322444, 47.603916 ], [ -122.32344, 47.603899 ], [ -122.323315, 47.604594 ], [ -122.323117, 47.604808 ], [ -122.322743, 47.604889 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13145", "project_id": 13, "task_id": 145, "numnodechanges": 301, "numwaychanges": 27 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325212, 47.605792 ], [ -122.325559, 47.60578 ], [ -122.325868, 47.606509 ], [ -122.325624, 47.60673 ], [ -122.325284, 47.606767 ], [ -122.32497, 47.606016 ], [ -122.325212, 47.605792 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13131", "project_id": 13, "task_id": 131, "numnodechanges": 211, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332495, 47.603745 ], [ -122.332837, 47.603709 ], [ -122.333157, 47.604452 ], [ -122.332982, 47.604615 ], [ -122.332676, 47.604678 ], [ -122.3326, 47.604685 ], [ -122.332279, 47.603941 ], [ -122.332495, 47.603745 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13172", "project_id": 13, "task_id": 172, "numnodechanges": 49, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331682, 47.608373 ], [ -122.331337, 47.608306 ], [ -122.331852, 47.607827 ], [ -122.332121, 47.607952 ], [ -122.332119, 47.607964 ], [ -122.331682, 47.608373 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13425", "project_id": 13, "task_id": 425, "numnodechanges": 1, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326183, 47.596581 ], [ -122.326182, 47.5971 ], [ -122.32605, 47.597162 ], [ -122.325852, 47.5971 ], [ -122.325855, 47.596261 ], [ -122.325948, 47.596234 ], [ -122.326035, 47.596304 ], [ -122.326137, 47.596478 ], [ -122.326183, 47.596581 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13304", "project_id": 13, "task_id": 304, "numnodechanges": 46, "numwaychanges": 17 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332759, 47.608844 ], [ -122.332954, 47.609308 ], [ -122.332663, 47.609367 ], [ -122.332475, 47.6091 ], [ -122.332759, 47.608844 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13503", "project_id": 13, "task_id": 503, "numnodechanges": 42, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329411, 47.601464 ], [ -122.32863, 47.60147 ], [ -122.328841, 47.60114 ], [ -122.32921, 47.601138 ], [ -122.329435, 47.601313 ], [ -122.329411, 47.601464 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13386", "project_id": 13, "task_id": 386, "numnodechanges": 338, "numwaychanges": 20 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330733, 47.604575 ], [ -122.330784, 47.604616 ], [ -122.330937, 47.604991 ], [ -122.330363, 47.60551 ], [ -122.330154, 47.605 ], [ -122.330564, 47.604621 ], [ -122.330731, 47.604575 ], [ -122.330733, 47.604575 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13305", "project_id": 13, "task_id": 305, "numnodechanges": 4, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332937, 47.608502 ], [ -122.333247, 47.609241 ], [ -122.333202, 47.609257 ], [ -122.332954, 47.609308 ], [ -122.332759, 47.608844 ], [ -122.332773, 47.608613 ], [ -122.332937, 47.608502 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13377", "project_id": 13, "task_id": 377, "numnodechanges": 29, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328223, 47.598692 ], [ -122.32822, 47.599598 ], [ -122.328121, 47.599635 ], [ -122.327841, 47.599421 ], [ -122.327842, 47.598988 ], [ -122.328223, 47.598692 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1341", "project_id": 13, "task_id": 41, "numnodechanges": 93, "numwaychanges": 15 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319745, 47.604792 ], [ -122.319743, 47.605712 ], [ -122.319485, 47.605711 ], [ -122.319371, 47.605568 ], [ -122.319373, 47.604791 ], [ -122.319378, 47.60479 ], [ -122.31974, 47.604788 ], [ -122.319745, 47.604792 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13335", "project_id": 13, "task_id": 335, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336312, 47.599671 ], [ -122.336391, 47.599886 ], [ -122.335789, 47.599916 ], [ -122.335452, 47.59963 ], [ -122.335784, 47.599496 ], [ -122.336075, 47.599489 ], [ -122.336284, 47.59964 ], [ -122.336312, 47.599671 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13219", "project_id": 13, "task_id": 219, "numnodechanges": 2, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331915, 47.598523 ], [ -122.331917, 47.59782 ], [ -122.332571, 47.597387 ], [ -122.332567, 47.598518 ], [ -122.332562, 47.598526 ], [ -122.331915, 47.598523 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1359", "project_id": 13, "task_id": 59, "numnodechanges": 137, "numwaychanges": 23 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326572, 47.609239 ], [ -122.326488, 47.609317 ], [ -122.326027, 47.609106 ], [ -122.325824, 47.608619 ], [ -122.326183, 47.608287 ], [ -122.326572, 47.609239 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13102", "project_id": 13, "task_id": 102, "numnodechanges": 5, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335642, 47.606375 ], [ -122.336013, 47.607267 ], [ -122.335672, 47.607383 ], [ -122.335285, 47.606439 ], [ -122.335337, 47.606344 ], [ -122.335642, 47.606375 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13499", "project_id": 13, "task_id": 499, "numnodechanges": 30, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333005, 47.603551 ], [ -122.332981, 47.603346 ], [ -122.333456, 47.60291 ], [ -122.333776, 47.603254 ], [ -122.333429, 47.603573 ], [ -122.333005, 47.603551 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1351", "project_id": 13, "task_id": 51, "numnodechanges": 347, "numwaychanges": 20 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321092, 47.606357 ], [ -122.32094, 47.606639 ], [ -122.320323, 47.606633 ], [ -122.320436, 47.606314 ], [ -122.321092, 47.606357 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13458", "project_id": 13, "task_id": 458, "numnodechanges": 0, "numwaychanges": 0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328192, 47.601535 ], [ -122.328064, 47.601353 ], [ -122.328425, 47.600985 ], [ -122.328772, 47.60098 ], [ -122.328841, 47.60114 ], [ -122.32863, 47.60147 ], [ -122.328531, 47.601575 ], [ -122.328192, 47.601535 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13360", "project_id": 13, "task_id": 360, "numnodechanges": 165, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325497, 47.60087 ], [ -122.326031, 47.600458 ], [ -122.326694, 47.600458 ], [ -122.326697, 47.60046 ], [ -122.326691, 47.601304 ], [ -122.32603, 47.601294 ], [ -122.325497, 47.60087 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13390", "project_id": 13, "task_id": 390, "numnodechanges": 85, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3307, 47.604317 ], [ -122.331118, 47.603925 ], [ -122.331303, 47.604038 ], [ -122.330733, 47.604575 ], [ -122.330731, 47.604575 ], [ -122.3307, 47.604317 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13350", "project_id": 13, "task_id": 350, "numnodechanges": 193, "numwaychanges": 34 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337577, 47.604678 ], [ -122.337894, 47.605432 ], [ -122.337669, 47.605631 ], [ -122.337338, 47.605654 ], [ -122.337028, 47.604917 ], [ -122.337251, 47.604723 ], [ -122.337577, 47.604678 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13270", "project_id": 13, "task_id": 270, "numnodechanges": 240, "numwaychanges": 23 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322102, 47.602315 ], [ -122.322625, 47.602926 ], [ -122.322132, 47.603374 ], [ -122.321496, 47.603135 ], [ -122.321458, 47.602777 ], [ -122.321459, 47.602437 ], [ -122.321895, 47.602179 ], [ -122.322102, 47.602315 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1324", "project_id": 13, "task_id": 24, "numnodechanges": 29, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334803, 47.597513 ], [ -122.334781, 47.597438 ], [ -122.3349, 47.597224 ], [ -122.335022, 47.597128 ], [ -122.336707, 47.59749 ], [ -122.336755, 47.597529 ], [ -122.334956, 47.597652 ], [ -122.334803, 47.597513 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13338", "project_id": 13, "task_id": 338, "numnodechanges": 0, "numwaychanges": 0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336248, 47.598759 ], [ -122.336743, 47.59832 ], [ -122.337277, 47.597958 ], [ -122.337812, 47.598398 ], [ -122.336719, 47.599224 ], [ -122.336383, 47.599234 ], [ -122.336248, 47.598759 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13380", "project_id": 13, "task_id": 380, "numnodechanges": 42, "numwaychanges": 16 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329427, 47.598966 ], [ -122.329719, 47.598679 ], [ -122.329976, 47.599045 ], [ -122.329976, 47.599085 ], [ -122.329444, 47.599575 ], [ -122.329425, 47.599547 ], [ -122.329427, 47.598966 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1316", "project_id": 13, "task_id": 16, "numnodechanges": 24, "numwaychanges": 15 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323544, 47.599197 ], [ -122.324069, 47.5992 ], [ -122.324086, 47.599389 ], [ -122.32349, 47.599385 ], [ -122.323544, 47.599197 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13184", "project_id": 13, "task_id": 184, "numnodechanges": 0, "numwaychanges": 1 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326852, 47.595896 ], [ -122.327366, 47.595897 ], [ -122.327382, 47.595985 ], [ -122.32734, 47.596098 ], [ -122.326994, 47.596215 ], [ -122.326847, 47.596221 ], [ -122.326754, 47.596172 ], [ -122.326852, 47.595896 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13158", "project_id": 13, "task_id": 158, "numnodechanges": 351, "numwaychanges": 28 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32135, 47.60677 ], [ -122.321812, 47.606736 ], [ -122.321832, 47.606782 ], [ -122.321172, 47.607406 ], [ -122.321016, 47.607277 ], [ -122.321072, 47.607024 ], [ -122.32135, 47.60677 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13287", "project_id": 13, "task_id": 287, "numnodechanges": 22, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323973, 47.608213 ], [ -122.324231, 47.608012 ], [ -122.324799, 47.608114 ], [ -122.323947, 47.608879 ], [ -122.323934, 47.608874 ], [ -122.32372, 47.60861 ], [ -122.3238, 47.608395 ], [ -122.323973, 47.608213 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13322", "project_id": 13, "task_id": 322, "numnodechanges": 0, "numwaychanges": 0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324077, 47.598143 ], [ -122.323952, 47.59794 ], [ -122.324081, 47.597732 ], [ -122.324731, 47.597725 ], [ -122.324878, 47.597942 ], [ -122.324727, 47.598159 ], [ -122.324077, 47.598143 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13307", "project_id": 13, "task_id": 307, "numnodechanges": 140, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328463, 47.608623 ], [ -122.328807, 47.608304 ], [ -122.329081, 47.608188 ], [ -122.329249, 47.608168 ], [ -122.329568, 47.608923 ], [ -122.329128, 47.609336 ], [ -122.328686, 47.609164 ], [ -122.328463, 47.608623 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13133", "project_id": 13, "task_id": 133, "numnodechanges": 19, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319745, 47.603114 ], [ -122.319748, 47.602231 ], [ -122.320168, 47.602029 ], [ -122.320422, 47.602204 ], [ -122.320419, 47.602788 ], [ -122.320353, 47.60308 ], [ -122.320143, 47.603116 ], [ -122.319745, 47.603114 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13281", "project_id": 13, "task_id": 281, "numnodechanges": 4, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322216, 47.605777 ], [ -122.32201, 47.605286 ], [ -122.322231, 47.605085 ], [ -122.322573, 47.605046 ], [ -122.322886, 47.605796 ], [ -122.322663, 47.605992 ], [ -122.322216, 47.605777 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1358", "project_id": 13, "task_id": 58, "numnodechanges": 3, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326487, 47.608208 ], [ -122.326853, 47.609115 ], [ -122.326572, 47.609239 ], [ -122.326183, 47.608287 ], [ -122.326255, 47.60817 ], [ -122.326487, 47.608208 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1313", "project_id": 13, "task_id": 13, "numnodechanges": 1, "numwaychanges": 1 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331232, 47.609205 ], [ -122.331618, 47.609537 ], [ -122.331626, 47.609579 ], [ -122.331191, 47.609668 ], [ -122.330414, 47.60972 ], [ -122.330343, 47.609531 ], [ -122.330585, 47.609324 ], [ -122.331232, 47.609205 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13210", "project_id": 13, "task_id": 210, "numnodechanges": 4, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333841, 47.598887 ], [ -122.33451, 47.598884 ], [ -122.334513, 47.598935 ], [ -122.33419, 47.599116 ], [ -122.33396, 47.599116 ], [ -122.333826, 47.598921 ], [ -122.333841, 47.598887 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13419", "project_id": 13, "task_id": 419, "numnodechanges": 92, "numwaychanges": 17 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330594, 47.607661 ], [ -122.330246, 47.607529 ], [ -122.32999, 47.606922 ], [ -122.330553, 47.606555 ], [ -122.330748, 47.606538 ], [ -122.331075, 47.607319 ], [ -122.330594, 47.607661 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13117", "project_id": 13, "task_id": 117, "numnodechanges": 212, "numwaychanges": 34 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331827, 47.601279 ], [ -122.331378, 47.600913 ], [ -122.33138, 47.600462 ], [ -122.331905, 47.600471 ], [ -122.331901, 47.601243 ], [ -122.331827, 47.601279 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13109", "project_id": 13, "task_id": 109, "numnodechanges": 21, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334196, 47.598136 ], [ -122.334195, 47.598534 ], [ -122.333841, 47.598535 ], [ -122.333842, 47.598137 ], [ -122.334196, 47.598136 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13406", "project_id": 13, "task_id": 406, "numnodechanges": 0, "numwaychanges": 1 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32403, 47.605882 ], [ -122.324124, 47.605965 ], [ -122.324276, 47.606327 ], [ -122.324152, 47.606388 ], [ -122.323828, 47.606066 ], [ -122.32403, 47.605882 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13320", "project_id": 13, "task_id": 320, "numnodechanges": 11, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323246, 47.597092 ], [ -122.323248, 47.596531 ], [ -122.323565, 47.596417 ], [ -122.323563, 47.597092 ], [ -122.323429, 47.59715 ], [ -122.323246, 47.597092 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13185", "project_id": 13, "task_id": 185, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326718, 47.596173 ], [ -122.326547, 47.596011 ], [ -122.326548, 47.595674 ], [ -122.326833, 47.595728 ], [ -122.326853, 47.595763 ], [ -122.326852, 47.595896 ], [ -122.326754, 47.596172 ], [ -122.326718, 47.596173 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13137", "project_id": 13, "task_id": 137, "numnodechanges": 379, "numwaychanges": 31 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319748, 47.602231 ], [ -122.319745, 47.603114 ], [ -122.319705, 47.603144 ], [ -122.319252, 47.603109 ], [ -122.319318, 47.602166 ], [ -122.319748, 47.602231 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13231", "project_id": 13, "task_id": 231, "numnodechanges": 26, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329956, 47.599982 ], [ -122.330158, 47.599936 ], [ -122.33038, 47.599938 ], [ -122.330359, 47.600022 ], [ -122.329959, 47.600031 ], [ -122.329956, 47.599982 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1322", "project_id": 13, "task_id": 22, "numnodechanges": 15, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.338914, 47.601912 ], [ -122.338931, 47.601902 ], [ -122.339715, 47.601864 ], [ -122.339756, 47.602142 ], [ -122.338946, 47.602086 ], [ -122.338914, 47.601912 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13282", "project_id": 13, "task_id": 282, "numnodechanges": 21, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322657, 47.606026 ], [ -122.3223, 47.606352 ], [ -122.32184, 47.606404 ], [ -122.3218, 47.606158 ], [ -122.322216, 47.605777 ], [ -122.322663, 47.605992 ], [ -122.322657, 47.606026 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13112", "project_id": 13, "task_id": 112, "numnodechanges": 0, "numwaychanges": 0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33451, 47.598884 ], [ -122.334575, 47.598646 ], [ -122.334578, 47.598642 ], [ -122.335201, 47.598641 ], [ -122.335337, 47.598945 ], [ -122.33527, 47.599153 ], [ -122.334555, 47.599044 ], [ -122.334513, 47.598935 ], [ -122.33451, 47.598884 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13239", "project_id": 13, "task_id": 239, "numnodechanges": 207, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327634, 47.604659 ], [ -122.32761, 47.604708 ], [ -122.327184, 47.605077 ], [ -122.326558, 47.605139 ], [ -122.326533, 47.605129 ], [ -122.326226, 47.604395 ], [ -122.326372, 47.603792 ], [ -122.326569, 47.603794 ], [ -122.327398, 47.604102 ], [ -122.327634, 47.604659 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13285", "project_id": 13, "task_id": 285, "numnodechanges": 3, "numwaychanges": 1 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32446, 47.605655 ], [ -122.32476, 47.606039 ], [ -122.324448, 47.606327 ], [ -122.324276, 47.606327 ], [ -122.324124, 47.605965 ], [ -122.32446, 47.605655 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13336", "project_id": 13, "task_id": 336, "numnodechanges": 0, "numwaychanges": 0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337812, 47.598398 ], [ -122.338012, 47.598563 ], [ -122.338779, 47.59953 ], [ -122.33841, 47.599913 ], [ -122.337785, 47.60027 ], [ -122.33742, 47.600437 ], [ -122.336975, 47.600539 ], [ -122.336598, 47.600166 ], [ -122.336391, 47.599886 ], [ -122.336312, 47.599671 ], [ -122.336719, 47.599224 ], [ -122.337812, 47.598398 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1332", "project_id": 13, "task_id": 32, "numnodechanges": 18, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334584, 47.597988 ], [ -122.334803, 47.597513 ], [ -122.334956, 47.597652 ], [ -122.335112, 47.597829 ], [ -122.335254, 47.598088 ], [ -122.335273, 47.598473 ], [ -122.335201, 47.598641 ], [ -122.334578, 47.598642 ], [ -122.334584, 47.597988 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13303", "project_id": 13, "task_id": 303, "numnodechanges": 141, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332758, 47.60792 ], [ -122.33323, 47.607492 ], [ -122.333536, 47.608234 ], [ -122.333335, 47.608416 ], [ -122.333015, 47.608457 ], [ -122.332986, 47.608459 ], [ -122.332758, 47.60792 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13524", "project_id": 13, "task_id": 524, "numnodechanges": 22, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329421, 47.601818 ], [ -122.329067, 47.602049 ], [ -122.329022, 47.601631 ], [ -122.329414, 47.601561 ], [ -122.329422, 47.601592 ], [ -122.329421, 47.601818 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1373", "project_id": 13, "task_id": 73, "numnodechanges": 16, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334485, 47.596569 ], [ -122.332895, 47.596885 ], [ -122.332517, 47.59576 ], [ -122.333201, 47.5959 ], [ -122.334486, 47.596363 ], [ -122.334485, 47.596569 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1375", "project_id": 13, "task_id": 75, "numnodechanges": 25, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327016, 47.595536 ], [ -122.327041, 47.595487 ], [ -122.327556, 47.595453 ], [ -122.327364, 47.59584 ], [ -122.327222, 47.595764 ], [ -122.327016, 47.595536 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13242", "project_id": 13, "task_id": 242, "numnodechanges": 22, "numwaychanges": 12 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329976, 47.599085 ], [ -122.330071, 47.599337 ], [ -122.329684, 47.599693 ], [ -122.329463, 47.599628 ], [ -122.329444, 47.599575 ], [ -122.329976, 47.599085 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13324", "project_id": 13, "task_id": 324, "numnodechanges": 22, "numwaychanges": 14 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324096, 47.598775 ], [ -122.324069, 47.5992 ], [ -122.323544, 47.599197 ], [ -122.323548, 47.598753 ], [ -122.324075, 47.598756 ], [ -122.324096, 47.598775 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13243", "project_id": 13, "task_id": 243, "numnodechanges": 3, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329463, 47.599628 ], [ -122.329684, 47.599693 ], [ -122.329921, 47.599885 ], [ -122.329956, 47.599982 ], [ -122.329959, 47.600031 ], [ -122.329959, 47.60016 ], [ -122.329847, 47.600461 ], [ -122.329528, 47.600464 ], [ -122.329377, 47.600424 ], [ -122.329379, 47.599764 ], [ -122.329463, 47.599628 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13329", "project_id": 13, "task_id": 329, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334005, 47.607064 ], [ -122.333741, 47.606436 ], [ -122.333743, 47.606133 ], [ -122.334245, 47.606087 ], [ -122.334554, 47.606823 ], [ -122.334361, 47.607001 ], [ -122.334069, 47.607056 ], [ -122.334005, 47.607064 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13374", "project_id": 13, "task_id": 374, "numnodechanges": 103, "numwaychanges": 22 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327841, 47.599421 ], [ -122.327597, 47.599419 ], [ -122.327496, 47.598986 ], [ -122.327842, 47.598988 ], [ -122.327841, 47.599421 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13410", "project_id": 13, "task_id": 410, "numnodechanges": 75, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335781, 47.605399 ], [ -122.335174, 47.605956 ], [ -122.334973, 47.605829 ], [ -122.334957, 47.605496 ], [ -122.335397, 47.605092 ], [ -122.335781, 47.605399 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13246", "project_id": 13, "task_id": 246, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327348, 47.600376 ], [ -122.327254, 47.600463 ], [ -122.326697, 47.60046 ], [ -122.326694, 47.600458 ], [ -122.326696, 47.599897 ], [ -122.32735, 47.599901 ], [ -122.327348, 47.600376 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13465", "project_id": 13, "task_id": 465, "numnodechanges": 111, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329099, 47.599232 ], [ -122.329099, 47.599043 ], [ -122.329275, 47.598961 ], [ -122.329427, 47.598966 ], [ -122.329425, 47.599547 ], [ -122.329179, 47.59946 ], [ -122.329099, 47.599232 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13256", "project_id": 13, "task_id": 256, "numnodechanges": 0, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33181, 47.603988 ], [ -122.331734, 47.604096 ], [ -122.331303, 47.604038 ], [ -122.331118, 47.603925 ], [ -122.331026, 47.603702 ], [ -122.331051, 47.603246 ], [ -122.331536, 47.603316 ], [ -122.33181, 47.603988 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13278", "project_id": 13, "task_id": 278, "numnodechanges": 4, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324858, 47.60473 ], [ -122.325431, 47.604774 ], [ -122.325775, 47.605582 ], [ -122.325559, 47.60578 ], [ -122.325212, 47.605792 ], [ -122.324813, 47.604856 ], [ -122.324858, 47.60473 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13497", "project_id": 13, "task_id": 497, "numnodechanges": 79, "numwaychanges": 17 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334172, 47.603035 ], [ -122.333904, 47.602401 ], [ -122.33475, 47.60226 ], [ -122.335047, 47.602464 ], [ -122.335013, 47.602552 ], [ -122.334502, 47.603015 ], [ -122.334172, 47.603035 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13429", "project_id": 13, "task_id": 429, "numnodechanges": 8, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332237, 47.602422 ], [ -122.332343, 47.602673 ], [ -122.332351, 47.602846 ], [ -122.332191, 47.602994 ], [ -122.331847, 47.603033 ], [ -122.331502, 47.602207 ], [ -122.331585, 47.60213 ], [ -122.331775, 47.602133 ], [ -122.331945, 47.602199 ], [ -122.332074, 47.602253 ], [ -122.332237, 47.602422 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1380", "project_id": 13, "task_id": 80, "numnodechanges": 2, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32605, 47.597162 ], [ -122.326048, 47.597945 ], [ -122.326045, 47.597947 ], [ -122.325381, 47.597943 ], [ -122.325383, 47.597099 ], [ -122.325386, 47.597097 ], [ -122.325852, 47.5971 ], [ -122.32605, 47.597162 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1371", "project_id": 13, "task_id": 71, "numnodechanges": 125, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328243, 47.596898 ], [ -122.328358, 47.597347 ], [ -122.32836, 47.597705 ], [ -122.328296, 47.597955 ], [ -122.327361, 47.597949 ], [ -122.327032, 47.597696 ], [ -122.327033, 47.597208 ], [ -122.327322, 47.597024 ], [ -122.327649, 47.596869 ], [ -122.328153, 47.596872 ], [ -122.328243, 47.596898 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1343", "project_id": 13, "task_id": 43, "numnodechanges": 94, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319741, 47.603949 ], [ -122.31974, 47.604788 ], [ -122.319378, 47.60479 ], [ -122.319381, 47.603955 ], [ -122.319718, 47.603931 ], [ -122.319741, 47.603949 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13334", "project_id": 13, "task_id": 334, "numnodechanges": 0, "numwaychanges": 0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336719, 47.599224 ], [ -122.336312, 47.599671 ], [ -122.336284, 47.59964 ], [ -122.336383, 47.599234 ], [ -122.336719, 47.599224 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13223", "project_id": 13, "task_id": 223, "numnodechanges": 49, "numwaychanges": 17 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332571, 47.597387 ], [ -122.332906, 47.596937 ], [ -122.333077, 47.59709 ], [ -122.333072, 47.598523 ], [ -122.332567, 47.598518 ], [ -122.332571, 47.597387 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13508", "project_id": 13, "task_id": 508, "numnodechanges": 204, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330872, 47.601911 ], [ -122.330551, 47.601884 ], [ -122.330555, 47.60147 ], [ -122.330705, 47.601304 ], [ -122.33087, 47.601306 ], [ -122.330876, 47.601307 ], [ -122.330872, 47.601911 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13332", "project_id": 13, "task_id": 332, "numnodechanges": 15, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334226, 47.608216 ], [ -122.333961, 47.608187 ], [ -122.333586, 47.607276 ], [ -122.333885, 47.607175 ], [ -122.334276, 47.608125 ], [ -122.334226, 47.608216 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13209", "project_id": 13, "task_id": 209, "numnodechanges": 2, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33398, 47.599435 ], [ -122.334187, 47.599325 ], [ -122.334554, 47.599327 ], [ -122.334657, 47.599631 ], [ -122.33454, 47.599742 ], [ -122.334193, 47.599743 ], [ -122.333872, 47.599686 ], [ -122.33398, 47.599435 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13435", "project_id": 13, "task_id": 435, "numnodechanges": 38, "numwaychanges": 12 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334543, 47.601458 ], [ -122.334542, 47.601934 ], [ -122.334178, 47.601936 ], [ -122.334178, 47.601565 ], [ -122.334543, 47.601458 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13271", "project_id": 13, "task_id": 271, "numnodechanges": 232, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322625, 47.602926 ], [ -122.323293, 47.602724 ], [ -122.323689, 47.603663 ], [ -122.323689, 47.60367 ], [ -122.32344, 47.603899 ], [ -122.322444, 47.603916 ], [ -122.322225, 47.603593 ], [ -122.322132, 47.603374 ], [ -122.322625, 47.602926 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13427", "project_id": 13, "task_id": 427, "numnodechanges": 137, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332544, 47.601315 ], [ -122.332551, 47.60131 ], [ -122.3332, 47.60131 ], [ -122.3332, 47.601311 ], [ -122.333198, 47.601773 ], [ -122.332728, 47.602042 ], [ -122.332681, 47.602014 ], [ -122.332544, 47.601853 ], [ -122.332544, 47.601315 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13252", "project_id": 13, "task_id": 252, "numnodechanges": 20, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326704, 47.599195 ], [ -122.327233, 47.599198 ], [ -122.327232, 47.599512 ], [ -122.326676, 47.599508 ], [ -122.326704, 47.599195 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1317", "project_id": 13, "task_id": 17, "numnodechanges": 4, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32349, 47.599385 ], [ -122.324086, 47.599389 ], [ -122.324174, 47.599569 ], [ -122.32331, 47.599563 ], [ -122.32349, 47.599385 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13426", "project_id": 13, "task_id": 426, "numnodechanges": 13, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332681, 47.602014 ], [ -122.332237, 47.602422 ], [ -122.332074, 47.602253 ], [ -122.332489, 47.601872 ], [ -122.332544, 47.601853 ], [ -122.332681, 47.602014 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13518", "project_id": 13, "task_id": 518, "numnodechanges": 8, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334776, 47.603684 ], [ -122.335281, 47.603226 ], [ -122.33572, 47.603502 ], [ -122.335019, 47.604136 ], [ -122.334998, 47.604124 ], [ -122.334762, 47.603934 ], [ -122.334776, 47.603684 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13401", "project_id": 13, "task_id": 401, "numnodechanges": 32, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324152, 47.606388 ], [ -122.323926, 47.60659 ], [ -122.323476, 47.606559 ], [ -122.32346, 47.606354 ], [ -122.323788, 47.606061 ], [ -122.323828, 47.606066 ], [ -122.324152, 47.606388 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13359", "project_id": 13, "task_id": 359, "numnodechanges": 24, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325985, 47.60332 ], [ -122.326372, 47.603792 ], [ -122.326226, 47.604395 ], [ -122.325431, 47.604774 ], [ -122.324858, 47.60473 ], [ -122.324715, 47.604413 ], [ -122.325945, 47.603293 ], [ -122.325985, 47.60332 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13468", "project_id": 13, "task_id": 468, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331734, 47.604096 ], [ -122.33181, 47.603988 ], [ -122.332279, 47.603941 ], [ -122.3326, 47.604685 ], [ -122.332434, 47.604837 ], [ -122.331975, 47.604757 ], [ -122.331721, 47.604168 ], [ -122.331734, 47.604096 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13277", "project_id": 13, "task_id": 277, "numnodechanges": 22, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322018, 47.601945 ], [ -122.323256, 47.601947 ], [ -122.323365, 47.602292 ], [ -122.322102, 47.602315 ], [ -122.321895, 47.602179 ], [ -122.322018, 47.601945 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13492", "project_id": 13, "task_id": 492, "numnodechanges": 1, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333861, 47.60202 ], [ -122.334178, 47.601936 ], [ -122.334542, 47.601934 ], [ -122.33475, 47.60226 ], [ -122.333904, 47.602401 ], [ -122.333712, 47.602254 ], [ -122.333861, 47.60202 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13433", "project_id": 13, "task_id": 433, "numnodechanges": 5, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.338944, 47.602334 ], [ -122.339785, 47.60234 ], [ -122.33982, 47.602578 ], [ -122.339796, 47.60274 ], [ -122.338629, 47.602731 ], [ -122.338615, 47.6027 ], [ -122.338944, 47.602334 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13357", "project_id": 13, "task_id": 357, "numnodechanges": 12, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331775, 47.602133 ], [ -122.332099, 47.601827 ], [ -122.332306, 47.601856 ], [ -122.331945, 47.602199 ], [ -122.331775, 47.602133 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13379", "project_id": 13, "task_id": 379, "numnodechanges": 10, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328975, 47.598663 ], [ -122.329764, 47.598225 ], [ -122.329719, 47.598679 ], [ -122.329427, 47.598966 ], [ -122.329275, 47.598961 ], [ -122.328975, 47.598663 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13130", "project_id": 13, "task_id": 130, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333586, 47.607276 ], [ -122.333961, 47.608187 ], [ -122.333536, 47.608234 ], [ -122.33323, 47.607492 ], [ -122.333232, 47.607483 ], [ -122.333445, 47.607287 ], [ -122.333586, 47.607276 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13428", "project_id": 13, "task_id": 428, "numnodechanges": 56, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332681, 47.602014 ], [ -122.332728, 47.602042 ], [ -122.332805, 47.602226 ], [ -122.332343, 47.602673 ], [ -122.332237, 47.602422 ], [ -122.332681, 47.602014 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13408", "project_id": 13, "task_id": 408, "numnodechanges": 99, "numwaychanges": 19 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334957, 47.605496 ], [ -122.334745, 47.605 ], [ -122.335189, 47.604593 ], [ -122.335397, 47.605092 ], [ -122.334957, 47.605496 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1314", "project_id": 13, "task_id": 14, "numnodechanges": 26, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325413, 47.599768 ], [ -122.325366, 47.599935 ], [ -122.324716, 47.599931 ], [ -122.324666, 47.599763 ], [ -122.325413, 47.599768 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1353", "project_id": 13, "task_id": 53, "numnodechanges": 39, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322949, 47.608376 ], [ -122.323008, 47.608514 ], [ -122.322876, 47.608441 ], [ -122.322949, 47.608376 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13125", "project_id": 13, "task_id": 125, "numnodechanges": 150, "numwaychanges": 26 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327818, 47.605802 ], [ -122.327506, 47.605839 ], [ -122.327184, 47.605077 ], [ -122.32761, 47.604708 ], [ -122.328007, 47.605642 ], [ -122.327818, 47.605802 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13459", "project_id": 13, "task_id": 459, "numnodechanges": 9, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328583, 47.601635 ], [ -122.328883, 47.602181 ], [ -122.328862, 47.602312 ], [ -122.328665, 47.602495 ], [ -122.328447, 47.602527 ], [ -122.328113, 47.601715 ], [ -122.328192, 47.601535 ], [ -122.328531, 47.601575 ], [ -122.328583, 47.601635 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1386", "project_id": 13, "task_id": 86, "numnodechanges": 98, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32559, 47.596257 ], [ -122.325389, 47.596325 ], [ -122.32474, 47.596019 ], [ -122.324724, 47.595999 ], [ -122.324997, 47.5959 ], [ -122.325591, 47.595779 ], [ -122.32559, 47.596257 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13120", "project_id": 13, "task_id": 120, "numnodechanges": 98, "numwaychanges": 19 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329976, 47.599045 ], [ -122.330608, 47.598969 ], [ -122.330606, 47.599534 ], [ -122.330322, 47.599517 ], [ -122.330071, 47.599337 ], [ -122.329976, 47.599085 ], [ -122.329976, 47.599045 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13202", "project_id": 13, "task_id": 202, "numnodechanges": 16, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336975, 47.600539 ], [ -122.336971, 47.600543 ], [ -122.335961, 47.60058 ], [ -122.335789, 47.600403 ], [ -122.335779, 47.600168 ], [ -122.335791, 47.600154 ], [ -122.336598, 47.600166 ], [ -122.336975, 47.600539 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13525", "project_id": 13, "task_id": 525, "numnodechanges": 202, "numwaychanges": 23 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329768, 47.602134 ], [ -122.329326, 47.60253 ], [ -122.328862, 47.602312 ], [ -122.328883, 47.602181 ], [ -122.329067, 47.602049 ], [ -122.329421, 47.601818 ], [ -122.329768, 47.602134 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1311", "project_id": 13, "task_id": 11, "numnodechanges": 347, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322554, 47.607303 ], [ -122.322625, 47.607471 ], [ -122.322057, 47.607988 ], [ -122.321542, 47.607703 ], [ -122.322172, 47.607145 ], [ -122.322429, 47.607184 ], [ -122.322554, 47.607303 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13348", "project_id": 13, "task_id": 348, "numnodechanges": 120, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336985, 47.603046 ], [ -122.336709, 47.602998 ], [ -122.336437, 47.602587 ], [ -122.336325, 47.602302 ], [ -122.336478, 47.602175 ], [ -122.337014, 47.602048 ], [ -122.337054, 47.602061 ], [ -122.33739, 47.602464 ], [ -122.337462, 47.60261 ], [ -122.336985, 47.603046 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1370", "project_id": 13, "task_id": 70, "numnodechanges": 0, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328329, 47.596827 ], [ -122.330339, 47.596845 ], [ -122.33033, 47.597007 ], [ -122.330067, 47.597358 ], [ -122.328358, 47.597347 ], [ -122.328243, 47.596898 ], [ -122.328329, 47.596827 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13478", "project_id": 13, "task_id": 478, "numnodechanges": 81, "numwaychanges": 19 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331102, 47.607317 ], [ -122.331385, 47.607255 ], [ -122.331455, 47.607249 ], [ -122.331652, 47.607715 ], [ -122.331369, 47.607982 ], [ -122.331102, 47.607317 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13169", "project_id": 13, "task_id": 169, "numnodechanges": 181, "numwaychanges": 26 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328463, 47.608623 ], [ -122.328425, 47.608608 ], [ -122.328047, 47.607698 ], [ -122.328261, 47.6075 ], [ -122.328457, 47.60748 ], [ -122.328807, 47.608304 ], [ -122.328463, 47.608623 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13110", "project_id": 13, "task_id": 110, "numnodechanges": 6, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333346, 47.597269 ], [ -122.334781, 47.597438 ], [ -122.334803, 47.597513 ], [ -122.334584, 47.597988 ], [ -122.334196, 47.598136 ], [ -122.333842, 47.598137 ], [ -122.333403, 47.597415 ], [ -122.333346, 47.597269 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13403", "project_id": 13, "task_id": 403, "numnodechanges": 14, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324186, 47.60723 ], [ -122.324014, 47.607376 ], [ -122.32356, 47.607202 ], [ -122.32336, 47.606736 ], [ -122.323374, 47.606657 ], [ -122.323476, 47.606559 ], [ -122.323926, 47.60659 ], [ -122.324186, 47.60723 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13467", "project_id": 13, "task_id": 467, "numnodechanges": 19, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331975, 47.604757 ], [ -122.332434, 47.604837 ], [ -122.332431, 47.604983 ], [ -122.331924, 47.60547 ], [ -122.331577, 47.60518 ], [ -122.331614, 47.605102 ], [ -122.331975, 47.604757 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13279", "project_id": 13, "task_id": 279, "numnodechanges": 294, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324813, 47.604856 ], [ -122.325212, 47.605792 ], [ -122.32497, 47.606016 ], [ -122.32476, 47.606039 ], [ -122.32446, 47.605655 ], [ -122.324316, 47.605308 ], [ -122.324813, 47.604856 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13234", "project_id": 13, "task_id": 234, "numnodechanges": 20, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330609, 47.599538 ], [ -122.330697, 47.599625 ], [ -122.330685, 47.59967 ], [ -122.33038, 47.599938 ], [ -122.330158, 47.599936 ], [ -122.330609, 47.599538 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1381", "project_id": 13, "task_id": 81, "numnodechanges": 74, "numwaychanges": 22 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325386, 47.597097 ], [ -122.325383, 47.597099 ], [ -122.324736, 47.597095 ], [ -122.32474, 47.596019 ], [ -122.325389, 47.596325 ], [ -122.325386, 47.597097 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13372", "project_id": 13, "task_id": 372, "numnodechanges": 67, "numwaychanges": 12 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328377, 47.598176 ], [ -122.329763, 47.598149 ], [ -122.329769, 47.598208 ], [ -122.329764, 47.598225 ], [ -122.328975, 47.598663 ], [ -122.328513, 47.598641 ], [ -122.328358, 47.598514 ], [ -122.328377, 47.598176 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13155", "project_id": 13, "task_id": 155, "numnodechanges": 142, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322495, 47.608231 ], [ -122.322057, 47.607988 ], [ -122.322625, 47.607471 ], [ -122.322937, 47.607785 ], [ -122.322935, 47.607825 ], [ -122.322495, 47.608231 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13298", "project_id": 13, "task_id": 298, "numnodechanges": 29, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325133, 47.608877 ], [ -122.325318, 47.609323 ], [ -122.324996, 47.609257 ], [ -122.324789, 47.609182 ], [ -122.325133, 47.608877 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1318", "project_id": 13, "task_id": 18, "numnodechanges": 0, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336307, 47.606911 ], [ -122.336969, 47.606303 ], [ -122.337266, 47.60669 ], [ -122.336485, 47.607407 ], [ -122.336287, 47.607268 ], [ -122.336307, 47.606911 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13222", "project_id": 13, "task_id": 222, "numnodechanges": 25, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331917, 47.59782 ], [ -122.331062, 47.597819 ], [ -122.33033, 47.597007 ], [ -122.330339, 47.596845 ], [ -122.3308, 47.595463 ], [ -122.33119, 47.595489 ], [ -122.332517, 47.59576 ], [ -122.332895, 47.596885 ], [ -122.332906, 47.596937 ], [ -122.332571, 47.597387 ], [ -122.331917, 47.59782 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13400", "project_id": 13, "task_id": 400, "numnodechanges": 6, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324316, 47.605308 ], [ -122.32446, 47.605655 ], [ -122.324124, 47.605965 ], [ -122.32403, 47.605882 ], [ -122.323852, 47.605455 ], [ -122.32388, 47.60543 ], [ -122.32416, 47.605322 ], [ -122.324316, 47.605308 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13288", "project_id": 13, "task_id": 288, "numnodechanges": 265, "numwaychanges": 20 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323999, 47.607452 ], [ -122.324231, 47.608012 ], [ -122.323973, 47.608213 ], [ -122.32375, 47.607679 ], [ -122.323999, 47.607452 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1366", "project_id": 13, "task_id": 66, "numnodechanges": 4, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323195, 47.599656 ], [ -122.32331, 47.599563 ], [ -122.324174, 47.599569 ], [ -122.324197, 47.599606 ], [ -122.324162, 47.599662 ], [ -122.323195, 47.599656 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13295", "project_id": 13, "task_id": 295, "numnodechanges": 120, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325021, 47.608332 ], [ -122.324938, 47.608125 ], [ -122.325382, 47.607715 ], [ -122.326007, 47.60765 ], [ -122.326043, 47.607664 ], [ -122.326255, 47.60817 ], [ -122.326183, 47.608287 ], [ -122.325824, 47.608619 ], [ -122.325381, 47.608665 ], [ -122.325242, 47.608646 ], [ -122.325021, 47.608332 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13261", "project_id": 13, "task_id": 261, "numnodechanges": 7, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320132, 47.603949 ], [ -122.320143, 47.603116 ], [ -122.320353, 47.60308 ], [ -122.320499, 47.603202 ], [ -122.32049, 47.603883 ], [ -122.320401, 47.603958 ], [ -122.320339, 47.603985 ], [ -122.320132, 47.603949 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13325", "project_id": 13, "task_id": 325, "numnodechanges": 4, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32472, 47.599439 ], [ -122.324584, 47.599608 ], [ -122.324197, 47.599606 ], [ -122.324174, 47.599569 ], [ -122.324086, 47.599389 ], [ -122.324069, 47.5992 ], [ -122.324096, 47.598775 ], [ -122.324722, 47.598779 ], [ -122.32472, 47.599439 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13269", "project_id": 13, "task_id": 269, "numnodechanges": 8, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320429, 47.604902 ], [ -122.320427, 47.605587 ], [ -122.320301, 47.605711 ], [ -122.319747, 47.605714 ], [ -122.319743, 47.605712 ], [ -122.319745, 47.604792 ], [ -122.320312, 47.604791 ], [ -122.320359, 47.604821 ], [ -122.320429, 47.604902 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13283", "project_id": 13, "task_id": 283, "numnodechanges": 10, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323333, 47.606052 ], [ -122.322904, 47.605795 ], [ -122.323356, 47.605382 ], [ -122.323777, 47.605482 ], [ -122.32366, 47.605752 ], [ -122.323333, 47.606052 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13103", "project_id": 13, "task_id": 103, "numnodechanges": 6, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33238, 47.599628 ], [ -122.332153, 47.599632 ], [ -122.332155, 47.598979 ], [ -122.332444, 47.598979 ], [ -122.33238, 47.599628 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13440", "project_id": 13, "task_id": 440, "numnodechanges": 159, "numwaychanges": 21 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3352, 47.601307 ], [ -122.335266, 47.601252 ], [ -122.335422, 47.601281 ], [ -122.335893, 47.601685 ], [ -122.335915, 47.602226 ], [ -122.335577, 47.602381 ], [ -122.335197, 47.602383 ], [ -122.3352, 47.601307 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13514", "project_id": 13, "task_id": 514, "numnodechanges": 113, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334502, 47.603015 ], [ -122.335013, 47.602552 ], [ -122.335281, 47.603226 ], [ -122.334776, 47.603684 ], [ -122.334502, 47.603015 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "133", "project_id": 13, "task_id": 3, "numnodechanges": 9, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328377, 47.598176 ], [ -122.328296, 47.597955 ], [ -122.32836, 47.597705 ], [ -122.329895, 47.597686 ], [ -122.329763, 47.598149 ], [ -122.328377, 47.598176 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13423", "project_id": 13, "task_id": 423, "numnodechanges": 86, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326547, 47.596589 ], [ -122.326826, 47.597104 ], [ -122.326182, 47.5971 ], [ -122.326183, 47.596581 ], [ -122.326547, 47.596589 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13229", "project_id": 13, "task_id": 229, "numnodechanges": 38, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33322, 47.599211 ], [ -122.333219, 47.59965 ], [ -122.332896, 47.599912 ], [ -122.332746, 47.599792 ], [ -122.332749, 47.599208 ], [ -122.33322, 47.599211 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13367", "project_id": 13, "task_id": 367, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328155, 47.603515 ], [ -122.328823, 47.603514 ], [ -122.329079, 47.604134 ], [ -122.329039, 47.604389 ], [ -122.328744, 47.604392 ], [ -122.328385, 47.604072 ], [ -122.328155, 47.603515 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13216", "project_id": 13, "task_id": 216, "numnodechanges": 59, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336238, 47.605397 ], [ -122.336067, 47.605351 ], [ -122.335702, 47.604474 ], [ -122.335989, 47.604296 ], [ -122.336376, 47.605226 ], [ -122.336238, 47.605397 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1321", "project_id": 13, "task_id": 21, "numnodechanges": 12, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.338946, 47.602086 ], [ -122.339756, 47.602142 ], [ -122.339785, 47.60234 ], [ -122.338944, 47.602334 ], [ -122.338946, 47.602086 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "139", "project_id": 13, "task_id": 9, "numnodechanges": 7, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33822, 47.605394 ], [ -122.338475, 47.606013 ], [ -122.338202, 47.606357 ], [ -122.33798, 47.606376 ], [ -122.337669, 47.605631 ], [ -122.337894, 47.605432 ], [ -122.33822, 47.605394 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1357", "project_id": 13, "task_id": 57, "numnodechanges": 188, "numwaychanges": 19 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326007, 47.60765 ], [ -122.325624, 47.60673 ], [ -122.325868, 47.606509 ], [ -122.32597, 47.606505 ], [ -122.326339, 47.607392 ], [ -122.326043, 47.607664 ], [ -122.326007, 47.60765 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13532", "project_id": 13, "task_id": 532, "numnodechanges": 175, "numwaychanges": 19 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329326, 47.60253 ], [ -122.329768, 47.602134 ], [ -122.329895, 47.602156 ], [ -122.330135, 47.602255 ], [ -122.330236, 47.602333 ], [ -122.33027, 47.60242 ], [ -122.329547, 47.603063 ], [ -122.329326, 47.60253 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13135", "project_id": 13, "task_id": 135, "numnodechanges": 185, "numwaychanges": 19 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319318, 47.602166 ], [ -122.319252, 47.603109 ], [ -122.318992, 47.603175 ], [ -122.318987, 47.602157 ], [ -122.319049, 47.602047 ], [ -122.319318, 47.602166 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13535", "project_id": 13, "task_id": 535, "numnodechanges": 20, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329515, 47.603187 ], [ -122.329134, 47.603231 ], [ -122.328826, 47.602873 ], [ -122.328665, 47.602495 ], [ -122.328862, 47.602312 ], [ -122.329326, 47.60253 ], [ -122.329547, 47.603063 ], [ -122.329515, 47.603187 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13347", "project_id": 13, "task_id": 347, "numnodechanges": 36, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337054, 47.602061 ], [ -122.337423, 47.601725 ], [ -122.337702, 47.601849 ], [ -122.33739, 47.602464 ], [ -122.337054, 47.602061 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13456", "project_id": 13, "task_id": 456, "numnodechanges": 114, "numwaychanges": 22 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328772, 47.60098 ], [ -122.328774, 47.600799 ], [ -122.329211, 47.600798 ], [ -122.32921, 47.601138 ], [ -122.328841, 47.60114 ], [ -122.328772, 47.60098 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13476", "project_id": 13, "task_id": 476, "numnodechanges": 3, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327615, 47.607819 ], [ -122.327715, 47.607729 ], [ -122.328047, 47.607698 ], [ -122.328425, 47.608608 ], [ -122.328066, 47.608643 ], [ -122.327918, 47.608539 ], [ -122.327615, 47.607819 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13529", "project_id": 13, "task_id": 529, "numnodechanges": 8, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329414, 47.601561 ], [ -122.329411, 47.601464 ], [ -122.329435, 47.601313 ], [ -122.329524, 47.601256 ], [ -122.329904, 47.601155 ], [ -122.330092, 47.601448 ], [ -122.329894, 47.601626 ], [ -122.329422, 47.601592 ], [ -122.329414, 47.601561 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13533", "project_id": 13, "task_id": 533, "numnodechanges": 414, "numwaychanges": 23 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330657, 47.602716 ], [ -122.330749, 47.602757 ], [ -122.330916, 47.60316 ], [ -122.330287, 47.60373 ], [ -122.329997, 47.603728 ], [ -122.329761, 47.603504 ], [ -122.330657, 47.602716 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1337", "project_id": 13, "task_id": 37, "numnodechanges": 62, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32681, 47.607123 ], [ -122.326339, 47.607392 ], [ -122.32597, 47.606505 ], [ -122.326459, 47.606377 ], [ -122.326503, 47.606387 ], [ -122.32681, 47.607123 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1395", "project_id": 13, "task_id": 95, "numnodechanges": 4, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33454, 47.599742 ], [ -122.334657, 47.599631 ], [ -122.335249, 47.59965 ], [ -122.335251, 47.600143 ], [ -122.335186, 47.600383 ], [ -122.335135, 47.600471 ], [ -122.334542, 47.600473 ], [ -122.33454, 47.599742 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13147", "project_id": 13, "task_id": 147, "numnodechanges": 239, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326533, 47.605129 ], [ -122.326558, 47.605139 ], [ -122.326949, 47.606064 ], [ -122.326919, 47.606093 ], [ -122.326503, 47.606387 ], [ -122.326459, 47.606377 ], [ -122.326098, 47.605523 ], [ -122.326533, 47.605129 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13519", "project_id": 13, "task_id": 519, "numnodechanges": 33, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334998, 47.604124 ], [ -122.335019, 47.604136 ], [ -122.335228, 47.60448 ], [ -122.335189, 47.604593 ], [ -122.334745, 47.605 ], [ -122.334316, 47.604984 ], [ -122.334291, 47.604773 ], [ -122.334998, 47.604124 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13292", "project_id": 13, "task_id": 292, "numnodechanges": 97, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323296, 47.607443 ], [ -122.323081, 47.607732 ], [ -122.322937, 47.607785 ], [ -122.322625, 47.607471 ], [ -122.322554, 47.607303 ], [ -122.323104, 47.606971 ], [ -122.323296, 47.607443 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13240", "project_id": 13, "task_id": 240, "numnodechanges": 78, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328826, 47.602873 ], [ -122.329134, 47.603231 ], [ -122.328823, 47.603514 ], [ -122.328155, 47.603515 ], [ -122.328128, 47.603499 ], [ -122.328826, 47.602873 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13286", "project_id": 13, "task_id": 286, "numnodechanges": 324, "numwaychanges": 20 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32375, 47.607679 ], [ -122.323973, 47.608213 ], [ -122.3238, 47.608395 ], [ -122.323551, 47.6078 ], [ -122.32375, 47.607679 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13368", "project_id": 13, "task_id": 368, "numnodechanges": 163, "numwaychanges": 23 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328744, 47.604392 ], [ -122.329039, 47.604389 ], [ -122.329266, 47.604615 ], [ -122.328502, 47.605298 ], [ -122.328289, 47.604798 ], [ -122.328744, 47.604392 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13513", "project_id": 13, "task_id": 513, "numnodechanges": 125, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33572, 47.603502 ], [ -122.335753, 47.6035 ], [ -122.336066, 47.604225 ], [ -122.335989, 47.604296 ], [ -122.335702, 47.604474 ], [ -122.335228, 47.60448 ], [ -122.335019, 47.604136 ], [ -122.33572, 47.603502 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13318", "project_id": 13, "task_id": 318, "numnodechanges": 4, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324086, 47.597093 ], [ -122.324733, 47.597097 ], [ -122.324731, 47.597725 ], [ -122.324081, 47.597732 ], [ -122.324083, 47.597095 ], [ -122.324086, 47.597093 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13510", "project_id": 13, "task_id": 510, "numnodechanges": 5, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330705, 47.601304 ], [ -122.330558, 47.601056 ], [ -122.330561, 47.600687 ], [ -122.330873, 47.600639 ], [ -122.33087, 47.601306 ], [ -122.330705, 47.601304 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1329", "project_id": 13, "task_id": 29, "numnodechanges": 64, "numwaychanges": 15 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335254, 47.598088 ], [ -122.335715, 47.598099 ], [ -122.335744, 47.598382 ], [ -122.335675, 47.598456 ], [ -122.335273, 47.598473 ], [ -122.335254, 47.598088 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13264", "project_id": 13, "task_id": 264, "numnodechanges": 54, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321021, 47.604405 ], [ -122.32088, 47.603878 ], [ -122.321266, 47.603649 ], [ -122.321506, 47.604203 ], [ -122.321527, 47.604415 ], [ -122.32136, 47.604576 ], [ -122.321266, 47.604585 ], [ -122.321021, 47.604405 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13346", "project_id": 13, "task_id": 346, "numnodechanges": 12, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337423, 47.601725 ], [ -122.33742, 47.600437 ], [ -122.337785, 47.60027 ], [ -122.337788, 47.60184 ], [ -122.337702, 47.601849 ], [ -122.337423, 47.601725 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1325", "project_id": 13, "task_id": 25, "numnodechanges": 2, "numwaychanges": 1 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3349, 47.597224 ], [ -122.334485, 47.596569 ], [ -122.334486, 47.596363 ], [ -122.335055, 47.596568 ], [ -122.335131, 47.596611 ], [ -122.33513, 47.596938 ], [ -122.335022, 47.597128 ], [ -122.3349, 47.597224 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1369", "project_id": 13, "task_id": 69, "numnodechanges": 84, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328695, 47.596009 ], [ -122.329076, 47.595352 ], [ -122.329099, 47.59535 ], [ -122.3308, 47.595463 ], [ -122.330339, 47.596845 ], [ -122.328329, 47.596827 ], [ -122.328695, 47.596009 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13446", "project_id": 13, "task_id": 446, "numnodechanges": 49, "numwaychanges": 16 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327618, 47.602835 ], [ -122.327287, 47.602417 ], [ -122.327268, 47.602312 ], [ -122.327363, 47.602168 ], [ -122.327896, 47.601936 ], [ -122.328194, 47.602661 ], [ -122.327886, 47.602944 ], [ -122.327618, 47.602835 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13181", "project_id": 13, "task_id": 181, "numnodechanges": 112, "numwaychanges": 17 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327364, 47.59584 ], [ -122.327556, 47.595453 ], [ -122.328079, 47.595418 ], [ -122.327877, 47.596006 ], [ -122.327865, 47.596025 ], [ -122.327382, 47.595985 ], [ -122.327366, 47.595897 ], [ -122.327364, 47.59584 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13536", "project_id": 13, "task_id": 536, "numnodechanges": 13, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329997, 47.603728 ], [ -122.329937, 47.603986 ], [ -122.329267, 47.604616 ], [ -122.329266, 47.604615 ], [ -122.329039, 47.604389 ], [ -122.329079, 47.604134 ], [ -122.329754, 47.6035 ], [ -122.329761, 47.603504 ], [ -122.329997, 47.603728 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13212", "project_id": 13, "task_id": 212, "numnodechanges": 16, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336478, 47.602175 ], [ -122.336325, 47.602302 ], [ -122.335915, 47.602226 ], [ -122.335893, 47.601685 ], [ -122.336452, 47.601165 ], [ -122.336472, 47.601157 ], [ -122.336478, 47.602175 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13496", "project_id": 13, "task_id": 496, "numnodechanges": 7, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3332, 47.601311 ], [ -122.3332, 47.60131 ], [ -122.333203, 47.60047 ], [ -122.333833, 47.600474 ], [ -122.333834, 47.601141 ], [ -122.333697, 47.601304 ], [ -122.333566, 47.601313 ], [ -122.3332, 47.601311 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13188", "project_id": 13, "task_id": 188, "numnodechanges": 12, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322866, 47.598729 ], [ -122.3232, 47.598762 ], [ -122.323191, 47.599658 ], [ -122.323091, 47.59978 ], [ -122.322904, 47.599955 ], [ -122.322832, 47.600011 ], [ -122.322731, 47.599105 ], [ -122.322771, 47.598926 ], [ -122.322866, 47.598729 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13469", "project_id": 13, "task_id": 469, "numnodechanges": 139, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331614, 47.605102 ], [ -122.331577, 47.60518 ], [ -122.331263, 47.605288 ], [ -122.330937, 47.604991 ], [ -122.330784, 47.604616 ], [ -122.331369, 47.604503 ], [ -122.331614, 47.605102 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13442", "project_id": 13, "task_id": 442, "numnodechanges": 67, "numwaychanges": 28 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326707, 47.601873 ], [ -122.326028, 47.601975 ], [ -122.32603, 47.601294 ], [ -122.326691, 47.601304 ], [ -122.326708, 47.601318 ], [ -122.326707, 47.601873 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13388", "project_id": 13, "task_id": 388, "numnodechanges": 4, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330356, 47.605646 ], [ -122.330222, 47.605762 ], [ -122.330074, 47.605796 ], [ -122.329723, 47.604941 ], [ -122.330154, 47.605 ], [ -122.330363, 47.60551 ], [ -122.330356, 47.605646 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1390", "project_id": 13, "task_id": 90, "numnodechanges": 3, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335534, 47.607509 ], [ -122.335809, 47.608172 ], [ -122.335289, 47.60846 ], [ -122.334985, 47.607727 ], [ -122.335201, 47.607537 ], [ -122.335534, 47.607509 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13144", "project_id": 13, "task_id": 144, "numnodechanges": 13, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324341, 47.604064 ], [ -122.323689, 47.60367 ], [ -122.323689, 47.603663 ], [ -122.325104, 47.602526 ], [ -122.325423, 47.60274 ], [ -122.324341, 47.604064 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "138", "project_id": 13, "task_id": 8, "numnodechanges": 139, "numwaychanges": 26 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.338542, 47.605104 ], [ -122.338917, 47.60517 ], [ -122.338996, 47.605355 ], [ -122.338475, 47.606013 ], [ -122.33822, 47.605394 ], [ -122.338542, 47.605104 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13105", "project_id": 13, "task_id": 105, "numnodechanges": 152, "numwaychanges": 26 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331822, 47.59945 ], [ -122.331253, 47.599457 ], [ -122.331255, 47.598748 ], [ -122.33175, 47.598762 ], [ -122.331824, 47.598867 ], [ -122.331822, 47.59945 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13119", "project_id": 13, "task_id": 119, "numnodechanges": 3, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33046, 47.600582 ], [ -122.330543, 47.600281 ], [ -122.330684, 47.600154 ], [ -122.331248, 47.600406 ], [ -122.331042, 47.600592 ], [ -122.330873, 47.600639 ], [ -122.330561, 47.600687 ], [ -122.33046, 47.600582 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13398", "project_id": 13, "task_id": 398, "numnodechanges": 12, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32361, 47.604776 ], [ -122.323315, 47.604594 ], [ -122.32344, 47.603899 ], [ -122.323689, 47.60367 ], [ -122.324341, 47.604064 ], [ -122.324492, 47.604251 ], [ -122.32393, 47.604767 ], [ -122.32361, 47.604776 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13118", "project_id": 13, "task_id": 118, "numnodechanges": 17, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331123, 47.599628 ], [ -122.33121, 47.599789 ], [ -122.331257, 47.599964 ], [ -122.331255, 47.600404 ], [ -122.331248, 47.600406 ], [ -122.330684, 47.600154 ], [ -122.330685, 47.59967 ], [ -122.330697, 47.599625 ], [ -122.331123, 47.599628 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13217", "project_id": 13, "task_id": 217, "numnodechanges": 83, "numwaychanges": 17 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335989, 47.604296 ], [ -122.336066, 47.604225 ], [ -122.336397, 47.604212 ], [ -122.336698, 47.604934 ], [ -122.336376, 47.605226 ], [ -122.335989, 47.604296 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13352", "project_id": 13, "task_id": 352, "numnodechanges": 21, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337078, 47.604301 ], [ -122.336702, 47.604001 ], [ -122.337197, 47.603551 ], [ -122.337226, 47.603563 ], [ -122.337624, 47.603803 ], [ -122.337078, 47.604301 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1389", "project_id": 13, "task_id": 89, "numnodechanges": 182, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334885, 47.606796 ], [ -122.335285, 47.606439 ], [ -122.335672, 47.607383 ], [ -122.335534, 47.607509 ], [ -122.335201, 47.607537 ], [ -122.334885, 47.606796 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13521", "project_id": 13, "task_id": 521, "numnodechanges": 51, "numwaychanges": 20 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329894, 47.601626 ], [ -122.330092, 47.601448 ], [ -122.330135, 47.601472 ], [ -122.330135, 47.602255 ], [ -122.329895, 47.602156 ], [ -122.329894, 47.601626 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13265", "project_id": 13, "task_id": 265, "numnodechanges": 143, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320401, 47.603958 ], [ -122.32049, 47.603883 ], [ -122.32088, 47.603878 ], [ -122.321021, 47.604405 ], [ -122.320771, 47.604408 ], [ -122.320401, 47.603958 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13291", "project_id": 13, "task_id": 291, "numnodechanges": 4, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324014, 47.607376 ], [ -122.323999, 47.607452 ], [ -122.32375, 47.607679 ], [ -122.323551, 47.6078 ], [ -122.323081, 47.607732 ], [ -122.323296, 47.607443 ], [ -122.32356, 47.607202 ], [ -122.324014, 47.607376 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13482", "project_id": 13, "task_id": 482, "numnodechanges": 9, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331455, 47.607249 ], [ -122.331695, 47.60704 ], [ -122.331811, 47.607031 ], [ -122.332177, 47.6079 ], [ -122.332121, 47.607952 ], [ -122.331852, 47.607827 ], [ -122.331652, 47.607715 ], [ -122.331455, 47.607249 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13245", "project_id": 13, "task_id": 245, "numnodechanges": 1, "numwaychanges": 1 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329764, 47.598225 ], [ -122.329769, 47.598208 ], [ -122.330725, 47.598758 ], [ -122.330608, 47.598969 ], [ -122.329976, 47.599045 ], [ -122.329719, 47.598679 ], [ -122.329764, 47.598225 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13204", "project_id": 13, "task_id": 204, "numnodechanges": 149, "numwaychanges": 12 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335942, 47.598851 ], [ -122.335675, 47.598456 ], [ -122.335744, 47.598382 ], [ -122.336743, 47.59832 ], [ -122.336248, 47.598759 ], [ -122.336105, 47.598843 ], [ -122.335942, 47.598851 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1393", "project_id": 13, "task_id": 93, "numnodechanges": 159, "numwaychanges": 27 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335784, 47.599496 ], [ -122.335452, 47.59963 ], [ -122.335273, 47.599627 ], [ -122.33527, 47.599153 ], [ -122.335337, 47.598945 ], [ -122.335781, 47.598918 ], [ -122.335784, 47.599496 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13200", "project_id": 13, "task_id": 200, "numnodechanges": 38, "numwaychanges": 12 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336598, 47.600166 ], [ -122.335791, 47.600154 ], [ -122.335789, 47.599916 ], [ -122.336391, 47.599886 ], [ -122.336598, 47.600166 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13168", "project_id": 13, "task_id": 168, "numnodechanges": 113, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327403, 47.606979 ], [ -122.327606, 47.606793 ], [ -122.327768, 47.606775 ], [ -122.328104, 47.60713 ], [ -122.328261, 47.6075 ], [ -122.328047, 47.607698 ], [ -122.327715, 47.607729 ], [ -122.327403, 47.606979 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13107", "project_id": 13, "task_id": 107, "numnodechanges": 6, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331123, 47.599628 ], [ -122.331253, 47.599457 ], [ -122.331822, 47.59945 ], [ -122.332023, 47.599659 ], [ -122.331961, 47.599779 ], [ -122.33121, 47.599789 ], [ -122.331123, 47.599628 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13438", "project_id": 13, "task_id": 438, "numnodechanges": 121, "numwaychanges": 19 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335047, 47.602464 ], [ -122.33475, 47.60226 ], [ -122.334542, 47.601934 ], [ -122.334543, 47.601458 ], [ -122.334608, 47.601319 ], [ -122.3352, 47.601307 ], [ -122.335197, 47.602383 ], [ -122.335047, 47.602464 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13317", "project_id": 13, "task_id": 317, "numnodechanges": 10, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323426, 47.597936 ], [ -122.322781, 47.597939 ], [ -122.322779, 47.597937 ], [ -122.322782, 47.597089 ], [ -122.323246, 47.597092 ], [ -122.323429, 47.59715 ], [ -122.323426, 47.597936 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13206", "project_id": 13, "task_id": 206, "numnodechanges": 1, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331913, 47.600464 ], [ -122.331915, 47.599956 ], [ -122.331961, 47.599779 ], [ -122.332023, 47.599659 ], [ -122.332153, 47.599632 ], [ -122.33238, 47.599628 ], [ -122.332746, 47.599792 ], [ -122.332896, 47.599912 ], [ -122.332895, 47.600221 ], [ -122.332555, 47.600471 ], [ -122.331913, 47.600464 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13454", "project_id": 13, "task_id": 454, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327996, 47.601299 ], [ -122.327992, 47.600797 ], [ -122.328072, 47.600454 ], [ -122.328433, 47.600456 ], [ -122.328425, 47.600985 ], [ -122.328064, 47.601353 ], [ -122.327996, 47.601299 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13160", "project_id": 13, "task_id": 160, "numnodechanges": 0, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321832, 47.606782 ], [ -122.322172, 47.607145 ], [ -122.321542, 47.607703 ], [ -122.321518, 47.60769 ], [ -122.321172, 47.607406 ], [ -122.321832, 47.606782 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13258", "project_id": 13, "task_id": 258, "numnodechanges": 56, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332525, 47.605211 ], [ -122.332787, 47.605623 ], [ -122.332436, 47.605935 ], [ -122.332069, 47.605883 ], [ -122.332008, 47.605668 ], [ -122.332525, 47.605211 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13297", "project_id": 13, "task_id": 297, "numnodechanges": 11, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325242, 47.608646 ], [ -122.325381, 47.608665 ], [ -122.325686, 47.609398 ], [ -122.325318, 47.609323 ], [ -122.325133, 47.608877 ], [ -122.325242, 47.608646 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1387", "project_id": 13, "task_id": 87, "numnodechanges": 4, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324089, 47.596228 ], [ -122.324724, 47.595999 ], [ -122.32474, 47.596019 ], [ -122.324736, 47.597095 ], [ -122.324733, 47.597097 ], [ -122.324086, 47.597093 ], [ -122.324089, 47.596228 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13445", "project_id": 13, "task_id": 445, "numnodechanges": 121, "numwaychanges": 22 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327352, 47.601287 ], [ -122.327344, 47.600804 ], [ -122.327992, 47.600797 ], [ -122.327996, 47.601299 ], [ -122.327358, 47.601291 ], [ -122.327352, 47.601287 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13343", "project_id": 13, "task_id": 343, "numnodechanges": 20, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332544, 47.601315 ], [ -122.332101, 47.601305 ], [ -122.331901, 47.601243 ], [ -122.331905, 47.600471 ], [ -122.331913, 47.600464 ], [ -122.332555, 47.600471 ], [ -122.332551, 47.60131 ], [ -122.332544, 47.601315 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13183", "project_id": 13, "task_id": 183, "numnodechanges": 144, "numwaychanges": 29 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326909, 47.597131 ], [ -122.327033, 47.597208 ], [ -122.327032, 47.597696 ], [ -122.326708, 47.597949 ], [ -122.326048, 47.597945 ], [ -122.32605, 47.597162 ], [ -122.326182, 47.5971 ], [ -122.326826, 47.597104 ], [ -122.326909, 47.597131 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13393", "project_id": 13, "task_id": 393, "numnodechanges": 2, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331236, 47.605375 ], [ -122.331263, 47.605288 ], [ -122.331577, 47.60518 ], [ -122.331924, 47.60547 ], [ -122.332008, 47.605668 ], [ -122.332069, 47.605883 ], [ -122.331951, 47.60598 ], [ -122.331485, 47.605956 ], [ -122.331236, 47.605375 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13111", "project_id": 13, "task_id": 111, "numnodechanges": 124, "numwaychanges": 20 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333072, 47.598523 ], [ -122.333077, 47.59709 ], [ -122.333346, 47.597269 ], [ -122.333403, 47.597415 ], [ -122.3334, 47.598533 ], [ -122.333227, 47.59865 ], [ -122.333072, 47.598523 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13316", "project_id": 13, "task_id": 316, "numnodechanges": 4, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323428, 47.597937 ], [ -122.323426, 47.598692 ], [ -122.3232, 47.598762 ], [ -122.322866, 47.598729 ], [ -122.322779, 47.598608 ], [ -122.322781, 47.597939 ], [ -122.323426, 47.597936 ], [ -122.323428, 47.597937 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13430", "project_id": 13, "task_id": 430, "numnodechanges": 4, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332074, 47.602253 ], [ -122.331945, 47.602199 ], [ -122.332306, 47.601856 ], [ -122.332489, 47.601872 ], [ -122.332074, 47.602253 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13276", "project_id": 13, "task_id": 276, "numnodechanges": 54, "numwaychanges": 16 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321459, 47.602437 ], [ -122.321151, 47.602199 ], [ -122.321158, 47.601358 ], [ -122.321351, 47.601279 ], [ -122.321542, 47.601272 ], [ -122.322015, 47.601366 ], [ -122.322018, 47.601945 ], [ -122.321895, 47.602179 ], [ -122.321459, 47.602437 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13342", "project_id": 13, "task_id": 342, "numnodechanges": 4, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333833, 47.600474 ], [ -122.333203, 47.60047 ], [ -122.332895, 47.600221 ], [ -122.332896, 47.599912 ], [ -122.333219, 47.59965 ], [ -122.333699, 47.599654 ], [ -122.333839, 47.599699 ], [ -122.333837, 47.600471 ], [ -122.333833, 47.600474 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1354", "project_id": 13, "task_id": 54, "numnodechanges": 14, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321106, 47.606346 ], [ -122.321118, 47.606079 ], [ -122.321306, 47.605663 ], [ -122.3218, 47.606158 ], [ -122.32184, 47.606404 ], [ -122.321826, 47.606435 ], [ -122.321184, 47.60639 ], [ -122.321106, 47.606346 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13434", "project_id": 13, "task_id": 434, "numnodechanges": 3, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.338226, 47.602022 ], [ -122.338408, 47.601737 ], [ -122.338914, 47.601912 ], [ -122.338946, 47.602086 ], [ -122.338944, 47.602334 ], [ -122.338615, 47.6027 ], [ -122.338205, 47.602402 ], [ -122.338226, 47.602022 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13527", "project_id": 13, "task_id": 527, "numnodechanges": 9, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329894, 47.601626 ], [ -122.329895, 47.602156 ], [ -122.329768, 47.602134 ], [ -122.329421, 47.601818 ], [ -122.329422, 47.601592 ], [ -122.329894, 47.601626 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13189", "project_id": 13, "task_id": 189, "numnodechanges": 0, "numwaychanges": 0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322282, 47.600131 ], [ -122.321632, 47.600759 ], [ -122.321367, 47.600759 ], [ -122.321167, 47.599969 ], [ -122.321497, 47.599861 ], [ -122.322196, 47.600077 ], [ -122.322282, 47.600131 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13473", "project_id": 13, "task_id": 473, "numnodechanges": 141, "numwaychanges": 27 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326934, 47.608154 ], [ -122.327151, 47.607958 ], [ -122.327335, 47.607945 ], [ -122.327553, 47.608461 ], [ -122.327198, 47.608787 ], [ -122.326934, 47.608154 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13244", "project_id": 13, "task_id": 244, "numnodechanges": 16, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329379, 47.599764 ], [ -122.329377, 47.600424 ], [ -122.32937, 47.600426 ], [ -122.329067, 47.600376 ], [ -122.329068, 47.599995 ], [ -122.329222, 47.599807 ], [ -122.329379, 47.599764 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1360", "project_id": 13, "task_id": 60, "numnodechanges": 26, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326813, 47.607124 ], [ -122.32681, 47.607123 ], [ -122.326503, 47.606387 ], [ -122.326919, 47.606093 ], [ -122.327292, 47.606993 ], [ -122.326813, 47.607124 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13449", "project_id": 13, "task_id": 449, "numnodechanges": 15, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327896, 47.601936 ], [ -122.328113, 47.601715 ], [ -122.328447, 47.602527 ], [ -122.328194, 47.602661 ], [ -122.327896, 47.601936 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13266", "project_id": 13, "task_id": 266, "numnodechanges": 230, "numwaychanges": 23 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321266, 47.604585 ], [ -122.32136, 47.604576 ], [ -122.321665, 47.605315 ], [ -122.321303, 47.605645 ], [ -122.321167, 47.60558 ], [ -122.320921, 47.604903 ], [ -122.321266, 47.604585 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13108", "project_id": 13, "task_id": 108, "numnodechanges": 14, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333842, 47.598137 ], [ -122.333841, 47.598535 ], [ -122.33384, 47.598536 ], [ -122.3334, 47.598533 ], [ -122.333403, 47.597415 ], [ -122.333842, 47.598137 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13165", "project_id": 13, "task_id": 165, "numnodechanges": 40, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325824, 47.608619 ], [ -122.326027, 47.609106 ], [ -122.325699, 47.609401 ], [ -122.325686, 47.609398 ], [ -122.325381, 47.608665 ], [ -122.325824, 47.608619 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13161", "project_id": 13, "task_id": 161, "numnodechanges": 20, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321184, 47.60639 ], [ -122.321826, 47.606435 ], [ -122.321812, 47.606736 ], [ -122.32135, 47.60677 ], [ -122.321184, 47.60639 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13461", "project_id": 13, "task_id": 461, "numnodechanges": 76, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328705, 47.599457 ], [ -122.328727, 47.599229 ], [ -122.329099, 47.599232 ], [ -122.329179, 47.59946 ], [ -122.328705, 47.599457 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13523", "project_id": 13, "task_id": 523, "numnodechanges": 62, "numwaychanges": 12 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329904, 47.601155 ], [ -122.329961, 47.601049 ], [ -122.330558, 47.601056 ], [ -122.330705, 47.601304 ], [ -122.330555, 47.60147 ], [ -122.330135, 47.601472 ], [ -122.330092, 47.601448 ], [ -122.329904, 47.601155 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13501", "project_id": 13, "task_id": 501, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333651, 47.604276 ], [ -122.333498, 47.604413 ], [ -122.333157, 47.604452 ], [ -122.332837, 47.603709 ], [ -122.333005, 47.603551 ], [ -122.333429, 47.603573 ], [ -122.333637, 47.604055 ], [ -122.333651, 47.604276 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13225", "project_id": 13, "task_id": 225, "numnodechanges": 15, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333221, 47.59896 ], [ -122.333748, 47.598961 ], [ -122.333673, 47.599212 ], [ -122.333222, 47.599201 ], [ -122.333221, 47.59896 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1320", "project_id": 13, "task_id": 20, "numnodechanges": 28, "numwaychanges": 1 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.338779, 47.59953 ], [ -122.339003, 47.599812 ], [ -122.339424, 47.600748 ], [ -122.338931, 47.601902 ], [ -122.338914, 47.601912 ], [ -122.338408, 47.601737 ], [ -122.33841, 47.599913 ], [ -122.338779, 47.59953 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13466", "project_id": 13, "task_id": 466, "numnodechanges": 188, "numwaychanges": 20 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331721, 47.604168 ], [ -122.331975, 47.604757 ], [ -122.331614, 47.605102 ], [ -122.331369, 47.604503 ], [ -122.331721, 47.604168 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13203", "project_id": 13, "task_id": 203, "numnodechanges": 206, "numwaychanges": 27 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336075, 47.599489 ], [ -122.335784, 47.599496 ], [ -122.335781, 47.598918 ], [ -122.335942, 47.598851 ], [ -122.336105, 47.598843 ], [ -122.336075, 47.599489 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13436", "project_id": 13, "task_id": 436, "numnodechanges": 17, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335871, 47.603117 ], [ -122.336437, 47.602587 ], [ -122.336709, 47.602998 ], [ -122.336335, 47.603349 ], [ -122.335893, 47.603371 ], [ -122.335871, 47.603117 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13262", "project_id": 13, "task_id": 262, "numnodechanges": 57, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319745, 47.604792 ], [ -122.31974, 47.604788 ], [ -122.319741, 47.603949 ], [ -122.320132, 47.603949 ], [ -122.320339, 47.603985 ], [ -122.320312, 47.604791 ], [ -122.319745, 47.604792 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13296", "project_id": 13, "task_id": 296, "numnodechanges": 135, "numwaychanges": 22 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324799, 47.608114 ], [ -122.324886, 47.608104 ], [ -122.324938, 47.608125 ], [ -122.325021, 47.608332 ], [ -122.324273, 47.608996 ], [ -122.323947, 47.608879 ], [ -122.324799, 47.608114 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13247", "project_id": 13, "task_id": 247, "numnodechanges": 93, "numwaychanges": 21 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327997, 47.599839 ], [ -122.327995, 47.60038 ], [ -122.327348, 47.600376 ], [ -122.32735, 47.599901 ], [ -122.327377, 47.599835 ], [ -122.327997, 47.599839 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13153", "project_id": 13, "task_id": 153, "numnodechanges": 2, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323713, 47.608609 ], [ -122.323476, 47.608709 ], [ -122.323143, 47.608589 ], [ -122.323008, 47.608514 ], [ -122.322949, 47.608376 ], [ -122.323047, 47.608104 ], [ -122.323713, 47.608609 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1376", "project_id": 13, "task_id": 76, "numnodechanges": 2, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326548, 47.595674 ], [ -122.32649, 47.595595 ], [ -122.326864, 47.595519 ], [ -122.326906, 47.595565 ], [ -122.326833, 47.595728 ], [ -122.326548, 47.595674 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13191", "project_id": 13, "task_id": 191, "numnodechanges": 23, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321542, 47.601272 ], [ -122.321351, 47.601279 ], [ -122.321357, 47.600795 ], [ -122.321367, 47.600759 ], [ -122.321632, 47.600759 ], [ -122.321542, 47.601272 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13387", "project_id": 13, "task_id": 387, "numnodechanges": 61, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330154, 47.605 ], [ -122.329723, 47.604941 ], [ -122.32955, 47.604888 ], [ -122.330099, 47.604379 ], [ -122.330564, 47.604621 ], [ -122.330154, 47.605 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13218", "project_id": 13, "task_id": 218, "numnodechanges": 141, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336698, 47.604934 ], [ -122.337028, 47.604917 ], [ -122.337338, 47.605654 ], [ -122.336874, 47.606075 ], [ -122.336455, 47.605913 ], [ -122.336238, 47.605397 ], [ -122.336376, 47.605226 ], [ -122.336698, 47.604934 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1338", "project_id": 13, "task_id": 38, "numnodechanges": 4, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328099, 47.606475 ], [ -122.328529, 47.606475 ], [ -122.32855, 47.606718 ], [ -122.328104, 47.60713 ], [ -122.327768, 47.606775 ], [ -122.328099, 47.606475 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13328", "project_id": 13, "task_id": 328, "numnodechanges": 56, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334276, 47.608125 ], [ -122.333885, 47.607175 ], [ -122.334005, 47.607064 ], [ -122.334069, 47.607056 ], [ -122.334458, 47.607956 ], [ -122.334276, 47.608125 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13268", "project_id": 13, "task_id": 268, "numnodechanges": 144, "numwaychanges": 22 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320921, 47.604903 ], [ -122.321167, 47.60558 ], [ -122.320427, 47.605587 ], [ -122.320429, 47.604902 ], [ -122.320921, 47.604903 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13378", "project_id": 13, "task_id": 378, "numnodechanges": 4, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327496, 47.598986 ], [ -122.327323, 47.598898 ], [ -122.327243, 47.598756 ], [ -122.32736, 47.598572 ], [ -122.328287, 47.598579 ], [ -122.328223, 47.598692 ], [ -122.327842, 47.598988 ], [ -122.327496, 47.598986 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13116", "project_id": 13, "task_id": 116, "numnodechanges": 82, "numwaychanges": 16 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331052, 47.601204 ], [ -122.331042, 47.600592 ], [ -122.331248, 47.600406 ], [ -122.331255, 47.600404 ], [ -122.33138, 47.600462 ], [ -122.331378, 47.600913 ], [ -122.331052, 47.601204 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13182", "project_id": 13, "task_id": 182, "numnodechanges": 0, "numwaychanges": 0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326994, 47.596215 ], [ -122.327322, 47.597024 ], [ -122.327033, 47.597208 ], [ -122.326909, 47.597131 ], [ -122.326847, 47.596221 ], [ -122.326994, 47.596215 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13226", "project_id": 13, "task_id": 226, "numnodechanges": 0, "numwaychanges": 0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333227, 47.59865 ], [ -122.3334, 47.598533 ], [ -122.33384, 47.598536 ], [ -122.333841, 47.598887 ], [ -122.333826, 47.598921 ], [ -122.333748, 47.598961 ], [ -122.333221, 47.59896 ], [ -122.333216, 47.598953 ], [ -122.333227, 47.59865 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13489", "project_id": 13, "task_id": 489, "numnodechanges": 16, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337538, 47.602622 ], [ -122.337462, 47.60261 ], [ -122.33739, 47.602464 ], [ -122.337702, 47.601849 ], [ -122.337788, 47.60184 ], [ -122.338226, 47.602022 ], [ -122.338205, 47.602402 ], [ -122.337894, 47.602541 ], [ -122.337538, 47.602622 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1350", "project_id": 13, "task_id": 50, "numnodechanges": 44, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320301, 47.605711 ], [ -122.320427, 47.605587 ], [ -122.321167, 47.60558 ], [ -122.321303, 47.605645 ], [ -122.321306, 47.605663 ], [ -122.321118, 47.606079 ], [ -122.320435, 47.606085 ], [ -122.320301, 47.605711 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13192", "project_id": 13, "task_id": 192, "numnodechanges": 3, "numwaychanges": 1 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322653, 47.600293 ], [ -122.322796, 47.60063 ], [ -122.322015, 47.601366 ], [ -122.321542, 47.601272 ], [ -122.321632, 47.600759 ], [ -122.322282, 47.600131 ], [ -122.322653, 47.600293 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13394", "project_id": 13, "task_id": 394, "numnodechanges": 142, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331912, 47.606216 ], [ -122.332186, 47.606871 ], [ -122.332114, 47.606935 ], [ -122.331811, 47.607031 ], [ -122.331695, 47.60704 ], [ -122.331505, 47.606585 ], [ -122.331912, 47.606216 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13486", "project_id": 13, "task_id": 486, "numnodechanges": 83, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.338653, 47.603405 ], [ -122.33902, 47.603784 ], [ -122.338284, 47.604451 ], [ -122.337892, 47.604385 ], [ -122.337653, 47.603812 ], [ -122.338029, 47.603469 ], [ -122.338144, 47.603437 ], [ -122.338653, 47.603405 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13236", "project_id": 13, "task_id": 236, "numnodechanges": 18, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328669, 47.599994 ], [ -122.329068, 47.599995 ], [ -122.329067, 47.600376 ], [ -122.328668, 47.600373 ], [ -122.328669, 47.599994 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1355", "project_id": 13, "task_id": 55, "numnodechanges": 337, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324886, 47.608104 ], [ -122.32451, 47.607201 ], [ -122.324736, 47.606998 ], [ -122.325069, 47.606965 ], [ -122.325382, 47.607715 ], [ -122.324938, 47.608125 ], [ -122.324886, 47.608104 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13530", "project_id": 13, "task_id": 530, "numnodechanges": 76, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329754, 47.6035 ], [ -122.329515, 47.603187 ], [ -122.329547, 47.603063 ], [ -122.33027, 47.60242 ], [ -122.330657, 47.602716 ], [ -122.329761, 47.603504 ], [ -122.329754, 47.6035 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13241", "project_id": 13, "task_id": 241, "numnodechanges": 23, "numwaychanges": 15 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329068, 47.599995 ], [ -122.328669, 47.599994 ], [ -122.328645, 47.599803 ], [ -122.329222, 47.599807 ], [ -122.329068, 47.599995 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13101", "project_id": 13, "task_id": 101, "numnodechanges": 0, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336048, 47.606287 ], [ -122.336307, 47.606911 ], [ -122.336287, 47.607268 ], [ -122.336013, 47.607267 ], [ -122.335642, 47.606375 ], [ -122.336048, 47.606287 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13411", "project_id": 13, "task_id": 411, "numnodechanges": 8, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335189, 47.604593 ], [ -122.335228, 47.60448 ], [ -122.335702, 47.604474 ], [ -122.336067, 47.605351 ], [ -122.335781, 47.605399 ], [ -122.335397, 47.605092 ], [ -122.335189, 47.604593 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13150", "project_id": 13, "task_id": 150, "numnodechanges": 281, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322216, 47.605777 ], [ -122.3218, 47.606158 ], [ -122.321306, 47.605663 ], [ -122.321303, 47.605645 ], [ -122.321665, 47.605315 ], [ -122.32201, 47.605286 ], [ -122.322216, 47.605777 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1346", "project_id": 13, "task_id": 46, "numnodechanges": 219, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318559, 47.601348 ], [ -122.318562, 47.601324 ], [ -122.319994, 47.600841 ], [ -122.320138, 47.601326 ], [ -122.318772, 47.601541 ], [ -122.318559, 47.601348 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13227", "project_id": 13, "task_id": 227, "numnodechanges": 4, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332566, 47.598889 ], [ -122.332562, 47.598526 ], [ -122.332567, 47.598518 ], [ -122.333072, 47.598523 ], [ -122.333227, 47.59865 ], [ -122.333216, 47.598953 ], [ -122.332674, 47.59895 ], [ -122.332566, 47.598889 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13220", "project_id": 13, "task_id": 220, "numnodechanges": 0, "numwaychanges": 0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332566, 47.598889 ], [ -122.332444, 47.598979 ], [ -122.332155, 47.598979 ], [ -122.331824, 47.598867 ], [ -122.33175, 47.598762 ], [ -122.331915, 47.598523 ], [ -122.332562, 47.598526 ], [ -122.332566, 47.598889 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13484", "project_id": 13, "task_id": 484, "numnodechanges": 81, "numwaychanges": 12 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.338144, 47.603437 ], [ -122.338029, 47.603469 ], [ -122.337725, 47.603097 ], [ -122.337538, 47.602622 ], [ -122.337894, 47.602541 ], [ -122.338144, 47.603437 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13457", "project_id": 13, "task_id": 457, "numnodechanges": 45, "numwaychanges": 16 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328113, 47.601715 ], [ -122.327896, 47.601936 ], [ -122.327363, 47.602168 ], [ -122.327358, 47.601291 ], [ -122.327996, 47.601299 ], [ -122.328064, 47.601353 ], [ -122.328192, 47.601535 ], [ -122.328113, 47.601715 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13441", "project_id": 13, "task_id": 441, "numnodechanges": 31, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327344, 47.600804 ], [ -122.327254, 47.600463 ], [ -122.327348, 47.600376 ], [ -122.327995, 47.60038 ], [ -122.328072, 47.600454 ], [ -122.327992, 47.600797 ], [ -122.327344, 47.600804 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13257", "project_id": 13, "task_id": 257, "numnodechanges": 188, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332191, 47.602994 ], [ -122.332495, 47.603745 ], [ -122.332279, 47.603941 ], [ -122.33181, 47.603988 ], [ -122.331536, 47.603316 ], [ -122.331847, 47.603033 ], [ -122.332191, 47.602994 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13267", "project_id": 13, "task_id": 267, "numnodechanges": 223, "numwaychanges": 33 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320312, 47.604791 ], [ -122.320339, 47.603985 ], [ -122.320401, 47.603958 ], [ -122.320771, 47.604408 ], [ -122.320359, 47.604821 ], [ -122.320312, 47.604791 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1330", "project_id": 13, "task_id": 30, "numnodechanges": 64, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335112, 47.597829 ], [ -122.336301, 47.597757 ], [ -122.335715, 47.598099 ], [ -122.335254, 47.598088 ], [ -122.335112, 47.597829 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13174", "project_id": 13, "task_id": 174, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332764, 47.606584 ], [ -122.333113, 47.607424 ], [ -122.332748, 47.60729 ], [ -122.332528, 47.606768 ], [ -122.332708, 47.606584 ], [ -122.332764, 47.606584 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13358", "project_id": 13, "task_id": 358, "numnodechanges": 21, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324715, 47.604413 ], [ -122.324492, 47.604251 ], [ -122.324341, 47.604064 ], [ -122.325423, 47.60274 ], [ -122.325543, 47.602786 ], [ -122.325673, 47.602907 ], [ -122.325945, 47.603293 ], [ -122.324715, 47.604413 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13483", "project_id": 13, "task_id": 483, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331652, 47.607715 ], [ -122.331852, 47.607827 ], [ -122.331337, 47.608306 ], [ -122.331179, 47.608284 ], [ -122.331369, 47.607982 ], [ -122.331652, 47.607715 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13166", "project_id": 13, "task_id": 166, "numnodechanges": 181, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334468, 47.605878 ], [ -122.334245, 47.606087 ], [ -122.333743, 47.606133 ], [ -122.333517, 47.605975 ], [ -122.33336, 47.605592 ], [ -122.333372, 47.605567 ], [ -122.33381, 47.605175 ], [ -122.334152, 47.60514 ], [ -122.334468, 47.605878 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13450", "project_id": 13, "task_id": 450, "numnodechanges": 8, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327268, 47.602312 ], [ -122.32685, 47.602095 ], [ -122.326707, 47.601873 ], [ -122.326708, 47.601318 ], [ -122.327352, 47.601287 ], [ -122.327358, 47.601291 ], [ -122.327363, 47.602168 ], [ -122.327268, 47.602312 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13333", "project_id": 13, "task_id": 333, "numnodechanges": 188, "numwaychanges": 27 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334687, 47.607767 ], [ -122.334985, 47.607727 ], [ -122.335289, 47.60846 ], [ -122.335056, 47.608589 ], [ -122.334468, 47.608801 ], [ -122.334226, 47.608216 ], [ -122.334276, 47.608125 ], [ -122.334458, 47.607956 ], [ -122.334687, 47.607767 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13341", "project_id": 13, "task_id": 341, "numnodechanges": 24, "numwaychanges": 12 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334183, 47.600473 ], [ -122.334186, 47.600473 ], [ -122.334537, 47.600476 ], [ -122.334538, 47.601219 ], [ -122.334184, 47.601142 ], [ -122.334183, 47.600473 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13232", "project_id": 13, "task_id": 232, "numnodechanges": 14, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330359, 47.600022 ], [ -122.330359, 47.600161 ], [ -122.329959, 47.60016 ], [ -122.329959, 47.600031 ], [ -122.330359, 47.600022 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13156", "project_id": 13, "task_id": 156, "numnodechanges": 10, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32497, 47.606016 ], [ -122.325284, 47.606767 ], [ -122.325069, 47.606965 ], [ -122.324736, 47.606998 ], [ -122.324448, 47.606327 ], [ -122.32476, 47.606039 ], [ -122.32497, 47.606016 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1342", "project_id": 13, "task_id": 42, "numnodechanges": 114, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319378, 47.60479 ], [ -122.319373, 47.604791 ], [ -122.31894, 47.60478 ], [ -122.318584, 47.603989 ], [ -122.318577, 47.60394 ], [ -122.319381, 47.603955 ], [ -122.319378, 47.60479 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13485", "project_id": 13, "task_id": 485, "numnodechanges": 14, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.338029, 47.603469 ], [ -122.337653, 47.603812 ], [ -122.337624, 47.603803 ], [ -122.337226, 47.603563 ], [ -122.337725, 47.603097 ], [ -122.338029, 47.603469 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13175", "project_id": 13, "task_id": 175, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333232, 47.607483 ], [ -122.33323, 47.607492 ], [ -122.332758, 47.60792 ], [ -122.332355, 47.607797 ], [ -122.332396, 47.607607 ], [ -122.332748, 47.60729 ], [ -122.333113, 47.607424 ], [ -122.333232, 47.607483 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13392", "project_id": 13, "task_id": 392, "numnodechanges": 0, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331951, 47.60598 ], [ -122.332069, 47.605883 ], [ -122.332436, 47.605935 ], [ -122.332708, 47.606584 ], [ -122.332528, 47.606768 ], [ -122.332186, 47.606871 ], [ -122.331912, 47.606216 ], [ -122.331951, 47.60598 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13314", "project_id": 13, "task_id": 314, "numnodechanges": 16, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325948, 47.596234 ], [ -122.326064, 47.59601 ], [ -122.326547, 47.596011 ], [ -122.326718, 47.596173 ], [ -122.326579, 47.596311 ], [ -122.326035, 47.596304 ], [ -122.325948, 47.596234 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13504", "project_id": 13, "task_id": 504, "numnodechanges": 97, "numwaychanges": 12 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32921, 47.601138 ], [ -122.329211, 47.600798 ], [ -122.32937, 47.600426 ], [ -122.329377, 47.600424 ], [ -122.329528, 47.600464 ], [ -122.329524, 47.601256 ], [ -122.329435, 47.601313 ], [ -122.32921, 47.601138 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13494", "project_id": 13, "task_id": 494, "numnodechanges": 10, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333572, 47.602272 ], [ -122.333293, 47.602536 ], [ -122.333189, 47.602548 ], [ -122.332805, 47.602226 ], [ -122.332728, 47.602042 ], [ -122.333198, 47.601773 ], [ -122.333563, 47.602259 ], [ -122.333572, 47.602272 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13253", "project_id": 13, "task_id": 253, "numnodechanges": 1, "numwaychanges": 1 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326676, 47.599508 ], [ -122.327232, 47.599512 ], [ -122.327329, 47.599588 ], [ -122.327377, 47.599835 ], [ -122.32735, 47.599901 ], [ -122.326696, 47.599897 ], [ -122.326584, 47.599614 ], [ -122.326676, 47.599508 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13139", "project_id": 13, "task_id": 139, "numnodechanges": 751, "numwaychanges": 26 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318772, 47.601541 ], [ -122.320138, 47.601326 ], [ -122.320173, 47.601367 ], [ -122.320168, 47.602029 ], [ -122.319748, 47.602231 ], [ -122.319318, 47.602166 ], [ -122.319049, 47.602047 ], [ -122.318772, 47.601541 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1339", "project_id": 13, "task_id": 39, "numnodechanges": 0, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333517, 47.605975 ], [ -122.333743, 47.606133 ], [ -122.333741, 47.606436 ], [ -122.333271, 47.606874 ], [ -122.332878, 47.606573 ], [ -122.333517, 47.605975 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13224", "project_id": 13, "task_id": 224, "numnodechanges": 30, "numwaychanges": 16 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333216, 47.598953 ], [ -122.333221, 47.59896 ], [ -122.333222, 47.599201 ], [ -122.33322, 47.599211 ], [ -122.332749, 47.599208 ], [ -122.332674, 47.59895 ], [ -122.333216, 47.598953 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13463", "project_id": 13, "task_id": 463, "numnodechanges": 69, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328727, 47.599229 ], [ -122.328728, 47.599035 ], [ -122.329099, 47.599043 ], [ -122.329099, 47.599232 ], [ -122.328727, 47.599229 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13167", "project_id": 13, "task_id": 167, "numnodechanges": 203, "numwaychanges": 27 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333335, 47.608416 ], [ -122.333536, 47.608234 ], [ -122.333961, 47.608187 ], [ -122.334226, 47.608216 ], [ -122.334468, 47.608801 ], [ -122.333624, 47.609105 ], [ -122.333335, 47.608416 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "13375", "project_id": 13, "task_id": 375, "numnodechanges": 8, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328121, 47.599635 ], [ -122.327997, 47.599839 ], [ -122.327377, 47.599835 ], [ -122.327329, 47.599588 ], [ -122.327597, 47.599419 ], [ -122.327841, 47.599421 ], [ -122.328121, 47.599635 ] ] ] ] } } +] +} diff --git a/tests/xnqm/inputs/p14_edges.geojson b/tests/xnqm/inputs/p14_edges.geojson new file mode 100755 index 0000000..5b1c5ec --- /dev/null +++ b/tests/xnqm/inputs/p14_edges.geojson @@ -0,0 +1,2720 @@ +{ +"type": "FeatureCollection", +"name": "p14_manual", +"crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:OGC:1.3:CRS84" } }, +"features": [ +{ "type": "Feature", "properties": { "id": 1151051, "project_id": 14, "task_id": 18 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319379, 47.5959922 ], [ -122.3193598, 47.5961838 ], [ -122.3193731, 47.5962588 ], [ -122.3193866, 47.59631 ], [ -122.3194082, 47.5963824 ], [ -122.3194822, 47.5965396 ], [ -122.3195346, 47.5966374 ], [ -122.3195549, 47.596678 ], [ -122.3195938, 47.5967543 ], [ -122.3196741, 47.596908 ], [ -122.3196901, 47.5969462 ], [ -122.3197184, 47.5970499 ], [ -122.3197279, 47.5970917 ], [ -122.3197281, 47.5971695 ], [ -122.3197258, 47.5972351 ], [ -122.3197272, 47.5974213 ] ] } }, +{ "type": "Feature", "properties": { "id": 1151053, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3248131, 47.6054418 ], [ -122.3250293, 47.6053597 ], [ -122.3255753, 47.6051224 ], [ -122.3257159, 47.6050568 ] ] } }, +{ "type": "Feature", "properties": { "id": 1151054, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3268017, 47.6045848 ], [ -122.3263844, 47.6047716 ], [ -122.3258866, 47.6049807 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156791, "project_id": 14, "task_id": 283 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166464, 47.6081243 ], [ -122.3162952, 47.6081226 ], [ -122.3157621, 47.6081263 ], [ -122.3155983, 47.6081245 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156792, "project_id": 14, "task_id": 113 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155793, 47.6091402 ], [ -122.315582, 47.608967 ], [ -122.3155854, 47.6083413 ], [ -122.3155877, 47.6081375 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156793, "project_id": 14, "task_id": 206 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166668, 47.6091265 ], [ -122.3166548, 47.6083532 ], [ -122.3166464, 47.6081243 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156798, "project_id": 14, "task_id": 259 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316922, 47.6081251 ], [ -122.317025, 47.6081249 ], [ -122.3173326, 47.6081241 ], [ -122.3173648, 47.6081244 ], [ -122.3180534, 47.6081281 ], [ -122.3181308, 47.6081281 ], [ -122.3181608, 47.6081283 ], [ -122.3181918, 47.6081284 ], [ -122.3182399, 47.6081297 ], [ -122.3182912, 47.6081325 ], [ -122.318317, 47.608132 ], [ -122.3183778, 47.6081294 ], [ -122.318397, 47.6081291 ], [ -122.318428, 47.6081288 ], [ -122.3184617, 47.6081269 ], [ -122.3185149, 47.6081244 ], [ -122.3185441, 47.6081222 ], [ -122.3185959, 47.6081151 ], [ -122.3186207, 47.6081107 ], [ -122.3186597, 47.6081025 ], [ -122.3186799, 47.6080985 ], [ -122.3187188, 47.6080919 ], [ -122.3187567, 47.6080847 ], [ -122.3188119, 47.6080727 ], [ -122.3188431, 47.6080662 ], [ -122.3189012, 47.6080548 ], [ -122.3189471, 47.6080456 ], [ -122.3189844, 47.6080375 ], [ -122.3190162, 47.6080293 ], [ -122.3190475, 47.6080211 ], [ -122.3190761, 47.6080136 ], [ -122.3191148, 47.6080027 ], [ -122.3191508, 47.6079915 ], [ -122.3191858, 47.6079807 ], [ -122.319215, 47.6079712 ], [ -122.3192541, 47.6079574 ], [ -122.3192866, 47.6079461 ], [ -122.3193176, 47.6079324 ], [ -122.3193436, 47.6079216 ], [ -122.3193717, 47.6079089 ], [ -122.3194008, 47.6078966 ], [ -122.3194412, 47.6078797 ], [ -122.3194769, 47.6078656 ], [ -122.3198979, 47.6076854 ], [ -122.3204782, 47.6074445 ], [ -122.3205746, 47.6074371 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156800, "project_id": 14, "task_id": 332 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169343, 47.6063081 ], [ -122.316937, 47.6063823 ], [ -122.3169395, 47.6064795 ], [ -122.3169356, 47.6066865 ], [ -122.316931, 47.6069245 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156801, "project_id": 14, "task_id": 283 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3143114, 47.608118 ], [ -122.3147772, 47.6081212 ], [ -122.3153479, 47.6081198 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156802, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142711, 47.6091325 ], [ -122.3142892, 47.6091451 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156804, "project_id": 14, "task_id": 113 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153584, 47.6091513 ], [ -122.3153624, 47.6089619 ], [ -122.3153631, 47.6086734 ], [ -122.315365, 47.6083598 ], [ -122.3153646, 47.6082317 ], [ -122.315362, 47.6081299 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156805, "project_id": 14, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153689, 47.6074992 ], [ -122.3153644, 47.6079554 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156806, "project_id": 14, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153716, 47.6073546 ], [ -122.3153728, 47.607136 ], [ -122.3153713, 47.6069088 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156807, "project_id": 14, "task_id": 331 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153755, 47.6063021 ], [ -122.3153731, 47.6064432 ], [ -122.3153744, 47.6065512 ], [ -122.315374, 47.6067666 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156808, "project_id": 14, "task_id": 283 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153523, 47.6079682 ], [ -122.3142827, 47.607962 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156810, "project_id": 14, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140661, 47.6062904 ], [ -122.3140664, 47.6062827 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156811, "project_id": 14, "task_id": 51 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127711, 47.6062868 ], [ -122.3127635, 47.606786 ], [ -122.3127638, 47.6073681 ], [ -122.31276, 47.6077115 ], [ -122.3127649, 47.607953 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156812, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127484, 47.6079524 ], [ -122.3116718, 47.6079515 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156813, "project_id": 14, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114428, 47.607929 ], [ -122.3114494, 47.6077501 ], [ -122.3114495, 47.6075668 ], [ -122.3114551, 47.6074056 ], [ -122.3114582, 47.6072911 ], [ -122.311463, 47.6068173 ], [ -122.3114646, 47.6066345 ], [ -122.3114623, 47.6064961 ], [ -122.3114665, 47.6062891 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156814, "project_id": 14, "task_id": 136 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114001, 47.6079528 ], [ -122.3108739, 47.6079492 ], [ -122.3105663, 47.6079469 ], [ -122.3103419, 47.6079469 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156816, "project_id": 14, "task_id": 136 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101218, 47.6080991 ], [ -122.3098901, 47.6080978 ], [ -122.3090651, 47.6080966 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156818, "project_id": 14, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077796, 47.6062607 ], [ -122.3088385, 47.606266 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156822, "project_id": 14, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3075368, 47.6062642 ], [ -122.3075417, 47.6065493 ], [ -122.3075311, 47.6078829 ] ] } }, +{ "type": "Feature", "properties": { "id": 1156823, "project_id": 14, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3075368, 47.6062642 ], [ -122.3069648, 47.6062607 ], [ -122.3064522, 47.6062543 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159210, "project_id": 14, "task_id": 255 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182282, 47.603584 ], [ -122.3182336, 47.6039427 ], [ -122.3182261, 47.604278 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159211, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182367, 47.6042857 ], [ -122.3187986, 47.6042879 ], [ -122.3193219, 47.604289 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159212, "project_id": 14, "task_id": 311 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169437, 47.6035807 ], [ -122.3169222, 47.6042745 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159213, "project_id": 13, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195492, 47.6043015 ], [ -122.3199303, 47.604301 ], [ -122.320158, 47.6043025 ], [ -122.320203, 47.6043041 ], [ -122.3203143, 47.6043097 ], [ -122.3203737, 47.6043137 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159214, "project_id": 13, "task_id": 135 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3188753, 47.6028355 ], [ -122.3189737, 47.6029308 ], [ -122.3191785, 47.6031277 ], [ -122.3197141, 47.6036534 ], [ -122.320011, 47.6039466 ], [ -122.3203599, 47.6042815 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159215, "project_id": 14, "task_id": 337 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316943, 47.6017729 ], [ -122.3170456, 47.601772 ], [ -122.3173183, 47.6017773 ], [ -122.3174115, 47.6017783 ], [ -122.3175036, 47.6017803 ], [ -122.3177555, 47.6017791 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159216, "project_id": 14, "task_id": 264 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180196, 47.6027561 ], [ -122.3180264, 47.6031128 ], [ -122.3180237, 47.6034576 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159217, "project_id": 14, "task_id": 311 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169468, 47.6034565 ], [ -122.3171166, 47.6034574 ], [ -122.3177777, 47.6034608 ], [ -122.318016, 47.6034622 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159218, "project_id": 14, "task_id": 388 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182335, 47.6044438 ], [ -122.318225, 47.6051298 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159219, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182388, 47.6051376 ], [ -122.3187948, 47.6051388 ], [ -122.3193322, 47.6051368 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159220, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182434, 47.604438 ], [ -122.3187568, 47.6044393 ], [ -122.3188356, 47.6044398 ], [ -122.3193162, 47.6044402 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159221, "project_id": 14, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31694, 47.6044327 ], [ -122.3171125, 47.6044355 ], [ -122.3177769, 47.60444 ], [ -122.3180074, 47.6044336 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159222, "project_id": 14, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169257, 47.6044381 ], [ -122.316937, 47.6047813 ], [ -122.3169403, 47.6051331 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159223, "project_id": 14, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180086, 47.6044377 ], [ -122.318008, 47.6047802 ], [ -122.3180166, 47.6051343 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159224, "project_id": 14, "task_id": 325 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.318235, 47.6052743 ], [ -122.3182407, 47.6057146 ], [ -122.3182356, 47.6060101 ], [ -122.3182355, 47.6060512 ], [ -122.3182349, 47.6061272 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159225, "project_id": 14, "task_id": 389 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192854, 47.6061405 ], [ -122.3187699, 47.6061371 ], [ -122.3182367, 47.606136 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159226, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182351, 47.6052617 ], [ -122.3186385, 47.6052722 ], [ -122.3187957, 47.605273 ], [ -122.3192201, 47.6052698 ], [ -122.3193336, 47.6052681 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159227, "project_id": 14, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169383, 47.6052704 ], [ -122.3174374, 47.6052676 ], [ -122.3179951, 47.6052723 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159228, "project_id": 14, "task_id": 392 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169379, 47.6056383 ], [ -122.3169389, 47.6053078 ] ] } }, +{ "type": "Feature", "properties": { "id": 1159229, "project_id": 14, "task_id": 325 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180111, 47.6052882 ], [ -122.3180105, 47.6057079 ], [ -122.3180129, 47.6060515 ], [ -122.318015, 47.6060867 ], [ -122.3180213, 47.6061367 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160044, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3222066, 47.6026125 ], [ -122.3222903, 47.6025618 ], [ -122.32232, 47.6025314 ], [ -122.3223702, 47.6024633 ], [ -122.322384, 47.602427 ], [ -122.3223904, 47.602374 ], [ -122.3223779, 47.6021969 ], [ -122.3223779, 47.6021951 ], [ -122.3223474, 47.6018152 ], [ -122.3223293, 47.6017849 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160045, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209455, 47.6017954 ], [ -122.3211478, 47.6017852 ], [ -122.3211919, 47.6017853 ], [ -122.3220106, 47.6017878 ], [ -122.3223293, 47.6017849 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160046, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220418, 47.6026401 ], [ -122.3219842, 47.6026204 ], [ -122.3219633, 47.60262 ], [ -122.3218869, 47.6026186 ], [ -122.3214426, 47.602618 ], [ -122.3209014, 47.6026216 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160048, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209033, 47.6035839 ], [ -122.3208999, 47.6038751 ], [ -122.3208993, 47.6040432 ], [ -122.3209017, 47.6040851 ], [ -122.3209043, 47.6041086 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160049, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3215905, 47.6038614 ], [ -122.3215536, 47.6038763 ], [ -122.3214606, 47.603892 ], [ -122.3211323, 47.6040306 ], [ -122.3210526, 47.6040636 ], [ -122.3209056, 47.6041209 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160050, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226499, 47.6033946 ], [ -122.3220887, 47.6027814 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160051, "project_id": 13, "task_id": 283 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236686, 47.6058924 ], [ -122.3231758, 47.6053552 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160052, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3254608, 47.6061682 ], [ -122.3256843, 47.6060721 ], [ -122.3262289, 47.6058285 ], [ -122.3263367, 47.6057872 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160053, "project_id": 13, "task_id": 401 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238328, 47.6060776 ], [ -122.3241292, 47.6063964 ], [ -122.3243377, 47.6066339 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160054, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3244362, 47.606755 ], [ -122.324594, 47.6066742 ], [ -122.3251539, 47.606456 ], [ -122.3253608, 47.6063774 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160055, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249832, 47.6073526 ], [ -122.3249384, 47.6073075 ], [ -122.3247915, 47.6071484 ], [ -122.3244362, 47.606755 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160056, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3256255, 47.6080585 ], [ -122.3254117, 47.6077931 ], [ -122.3251194, 47.6074777 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160393, "project_id": 13, "task_id": 451 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.328364, 47.6029742 ], [ -122.3280103, 47.6031221 ], [ -122.3278953, 47.6031704 ], [ -122.3274742, 47.6033497 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160394, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262023, 47.6001159 ], [ -122.325692, 47.6001143 ], [ -122.3252509, 47.6001146 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160395, "project_id": 14, "task_id": 152 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194944, 47.5992865 ], [ -122.3194203, 47.5992862 ], [ -122.3189853, 47.5992858 ], [ -122.3189477, 47.5993033 ], [ -122.3173788, 47.599321 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160396, "project_id": 13, "task_id": 46 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3196964, 47.6015946 ], [ -122.3196912, 47.6014043 ], [ -122.3196824, 47.601371 ], [ -122.3196671, 47.6013136 ], [ -122.3195959, 47.6010866 ], [ -122.3195891, 47.6010777 ], [ -122.3195588, 47.6010553 ], [ -122.3195524, 47.6010431 ], [ -122.3195395, 47.6009964 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160397, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223176, 47.6015779 ], [ -122.3220238, 47.6015757 ], [ -122.3211405, 47.6015767 ], [ -122.3209332, 47.6015789 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160398, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319686, 47.601788 ], [ -122.320037, 47.6017858 ], [ -122.3201805, 47.6017829 ], [ -122.3204515, 47.6017865 ] ] } }, +{ "type": "Feature", "properties": { "id": 1160876, "project_id": 14, "task_id": 39 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3128453, 47.5974065 ], [ -122.3124821, 47.596905 ], [ -122.3122685, 47.5966202 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161082, "project_id": 13, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206192, 47.6027585 ], [ -122.32053, 47.6027598 ], [ -122.3204127, 47.6027593 ], [ -122.3197504, 47.6027547 ], [ -122.3195588, 47.6027562 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161083, "project_id": 13, "task_id": 135 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3190795, 47.6027616 ], [ -122.3192576, 47.6029359 ], [ -122.3194384, 47.6031243 ], [ -122.3197112, 47.6033708 ], [ -122.3198467, 47.6035026 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161085, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209545, 47.604591 ], [ -122.3212711, 47.6049394 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161086, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208988, 47.60514 ], [ -122.3209091, 47.6048715 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161087, "project_id": 13, "task_id": 50 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208947, 47.6052888 ], [ -122.3208875, 47.6055824 ], [ -122.3208846, 47.6056999 ], [ -122.3208841, 47.6058054 ], [ -122.3208821, 47.6059304 ], [ -122.3208834, 47.6060373 ], [ -122.3208824, 47.6060777 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161088, "project_id": 13, "task_id": 50 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3217021, 47.605765 ], [ -122.3209189, 47.6060925 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161089, "project_id": 13, "task_id": 41 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206158, 47.6051502 ], [ -122.3201014, 47.6051344 ], [ -122.3200253, 47.6051241 ], [ -122.3195232, 47.6051325 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161090, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206106, 47.6045864 ], [ -122.320615, 47.6050355 ], [ -122.3206167, 47.6051056 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161091, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206016, 47.6061365 ], [ -122.3195193, 47.6061403 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161092, "project_id": 13, "task_id": 51 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3213028, 47.606674 ], [ -122.3212891, 47.6066573 ], [ -122.3211051, 47.6064406 ], [ -122.3210627, 47.6064063 ], [ -122.3210141, 47.606435 ], [ -122.320987, 47.6064276 ], [ -122.3209374, 47.6064188 ], [ -122.3209089, 47.6064069 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161093, "project_id": 13, "task_id": 159 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214531, 47.6068469 ], [ -122.3217042, 47.6067434 ], [ -122.321744, 47.6067271 ], [ -122.3217691, 47.6067158 ], [ -122.3219508, 47.6066318 ], [ -122.3219705, 47.6066213 ], [ -122.3223027, 47.6064789 ], [ -122.3223337, 47.6064507 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161094, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320961, 47.608047 ], [ -122.3219316, 47.6076415 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161095, "project_id": 14, "task_id": 176 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209269, 47.6100402 ], [ -122.3209362, 47.6100105 ], [ -122.3209013, 47.609484 ], [ -122.3208995, 47.6094394 ], [ -122.3208924, 47.6092961 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161096, "project_id": 14, "task_id": 82 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3232046, 47.60907 ], [ -122.3226605, 47.6092967 ], [ -122.3222049, 47.6095055 ], [ -122.3212924, 47.6098854 ], [ -122.3212455, 47.6098967 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161097, "project_id": 14, "task_id": 84 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3232076, 47.6090564 ], [ -122.3230875, 47.6089038 ], [ -122.3227717, 47.6085343 ], [ -122.3227205, 47.6084773 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161098, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3211351, 47.6081523 ], [ -122.3215842, 47.6079718 ], [ -122.3220405, 47.6077797 ] ] } }, +{ "type": "Feature", "properties": { "id": 1161099, "project_id": 14, "task_id": 173 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209085, 47.6082353 ], [ -122.3209127, 47.6083182 ], [ -122.3209102, 47.6083837 ], [ -122.3209098, 47.6084372 ], [ -122.3209089, 47.6085292 ], [ -122.3209044, 47.6086661 ], [ -122.3209024, 47.6087611 ], [ -122.3209051, 47.6088261 ], [ -122.3209129, 47.6090265 ], [ -122.3209127, 47.6090979 ], [ -122.3208963, 47.6091232 ] ] } }, +{ "type": "Feature", "properties": { "id": 1163143, "project_id": 14, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114818, 47.600931 ], [ -122.311475, 47.6016021 ] ] } }, +{ "type": "Feature", "properties": { "id": 1163144, "project_id": 14, "task_id": 226 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103963, 47.6016123 ], [ -122.3114423, 47.6016153 ] ] } }, +{ "type": "Feature", "properties": { "id": 1163145, "project_id": 14, "task_id": 226 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103945, 47.6017617 ], [ -122.3114575, 47.6017656 ] ] } }, +{ "type": "Feature", "properties": { "id": 1163146, "project_id": 14, "task_id": 294 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114757, 47.6017706 ], [ -122.3114725, 47.6019932 ], [ -122.3114669, 47.6025247 ], [ -122.3114661, 47.6026237 ] ] } }, +{ "type": "Feature", "properties": { "id": 1163147, "project_id": 14, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.312786, 47.6016087 ], [ -122.3127917, 47.600942 ] ] } }, +{ "type": "Feature", "properties": { "id": 1163148, "project_id": 14, "task_id": 291 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3113753, 47.6027383 ], [ -122.3113927, 47.6027441 ] ] } }, +{ "type": "Feature", "properties": { "id": 1163150, "project_id": 14, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103756, 47.6060933 ], [ -122.3109328, 47.6060931 ], [ -122.3114665, 47.6060917 ] ] } }, +{ "type": "Feature", "properties": { "id": 1163151, "project_id": 14, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114818, 47.6044494 ], [ -122.3114665, 47.6060917 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164093, "project_id": 13, "task_id": 14 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249677, 47.5999579 ], [ -122.3249661, 47.5998226 ], [ -122.3249629, 47.5996531 ], [ -122.3249575, 47.5995508 ], [ -122.3249557, 47.599327 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164094, "project_id": 13, "task_id": 67 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323893, 47.5999571 ], [ -122.3243934, 47.599964 ], [ -122.32495, 47.599958 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164095, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249554, 47.5990614 ], [ -122.3249723, 47.5987895 ], [ -122.3249751, 47.5984516 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164096, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239243, 47.5984323 ], [ -122.3240798, 47.5984314 ], [ -122.3249529, 47.5984379 ] ] } }, +{ "type": "Feature", "properties": { "id": 1164099, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323917, 47.5982801 ], [ -122.3240803, 47.5982815 ], [ -122.3249561, 47.598288 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166163, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264702, 47.5993328 ], [ -122.3264755, 47.5997319 ], [ -122.3264915, 47.5999326 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166164, "project_id": 13, "task_id": 246 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265315, 47.5999572 ], [ -122.3275147, 47.5999681 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166165, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235973, 47.5984358 ], [ -122.3234238, 47.5984358 ], [ -122.322587, 47.5984361 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166166, "project_id": 13, "task_id": 186 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225766, 47.5990718 ], [ -122.3225755, 47.599008 ], [ -122.322573, 47.5988438 ], [ -122.322573, 47.5986077 ], [ -122.3225735, 47.5984479 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166167, "project_id": 13, "task_id": 186 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223385, 47.599067 ], [ -122.3223376, 47.5990047 ], [ -122.3223373, 47.598922 ], [ -122.3223455, 47.598454 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166168, "project_id": 13, "task_id": 84 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197759, 47.5984222 ], [ -122.3223446, 47.5984299 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166169, "project_id": 14, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197568, 47.5990697 ], [ -122.3197647, 47.598769 ], [ -122.3197756, 47.5984283 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166170, "project_id": 14, "task_id": 12 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319513, 47.5984221 ], [ -122.3193045, 47.5984238 ], [ -122.3189112, 47.5984263 ], [ -122.3187171, 47.5984294 ], [ -122.3179691, 47.5984262 ], [ -122.3173854, 47.5984215 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166171, "project_id": 14, "task_id": 233 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314506, 47.5993029 ], [ -122.3145226, 47.5993261 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166173, "project_id": 14, "task_id": 62 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3171217, 47.5990913 ], [ -122.3171234, 47.598424 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166174, "project_id": 14, "task_id": 40 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3136299, 47.5984167 ], [ -122.3144402, 47.598414 ], [ -122.3149632, 47.5984159 ], [ -122.3154302, 47.5984177 ], [ -122.3159041, 47.5984174 ], [ -122.3160922, 47.5984197 ], [ -122.3162467, 47.59842 ], [ -122.3167838, 47.5984188 ], [ -122.3171171, 47.598417 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166175, "project_id": 14, "task_id": 193 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114844, 47.5991415 ], [ -122.3114881, 47.5988599 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166177, "project_id": 14, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3091036, 47.599146 ], [ -122.3091018, 47.598856 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166178, "project_id": 14, "task_id": 190 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114592, 47.5991476 ], [ -122.3103863, 47.5991564 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166179, "project_id": 14, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3104021, 47.5993327 ], [ -122.3104001, 47.5999273 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166180, "project_id": 14, "task_id": 205 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101641, 47.5993239 ], [ -122.3099395, 47.5993235 ], [ -122.3094177, 47.5993241 ], [ -122.3091045, 47.5993284 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166181, "project_id": 14, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090861, 47.5993327 ], [ -122.3091063, 47.5999312 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166182, "project_id": 14, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310174, 47.5993243 ], [ -122.3101744, 47.5999258 ] ] } }, +{ "type": "Feature", "properties": { "id": 1166183, "project_id": 14, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088609, 47.6015948 ], [ -122.3083137, 47.6015992 ], [ -122.3078799, 47.6016639 ] ] } }, +{ "type": "Feature", "properties": { "id": 1170618, "project_id": 14, "task_id": 212 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.313004, 47.6017678 ], [ -122.3140396, 47.6017686 ] ] } }, +{ "type": "Feature", "properties": { "id": 1170619, "project_id": 14, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140071, 47.6009348 ], [ -122.3140054, 47.6010957 ], [ -122.3140061, 47.6011521 ], [ -122.3140055, 47.6012645 ], [ -122.3140055, 47.6012963 ], [ -122.3140055, 47.6014447 ], [ -122.3140072, 47.6016041 ] ] } }, +{ "type": "Feature", "properties": { "id": 1170620, "project_id": 14, "task_id": 258 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314083, 47.6044267 ], [ -122.3140721, 47.6055007 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172020, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225937, 47.5974348 ], [ -122.322786, 47.5974363 ], [ -122.3234259, 47.5974412 ], [ -122.3236055, 47.5974421 ], [ -122.323605, 47.5974487 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172025, "project_id": 14, "task_id": 277 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3121799, 47.596931 ], [ -122.3118682, 47.5967446 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172066, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220868, 47.605818 ], [ -122.3221354, 47.6058704 ], [ -122.3221857, 47.6059272 ], [ -122.3222176, 47.6059626 ], [ -122.3222948, 47.60605 ], [ -122.3223679, 47.606126 ], [ -122.3224558, 47.6062181 ], [ -122.3225611, 47.6063333 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172067, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223348, 47.6047037 ], [ -122.3228378, 47.6052795 ], [ -122.3228342, 47.6052931 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172069, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223258, 47.604693 ], [ -122.3219151, 47.6048752 ], [ -122.3218223, 47.6049098 ], [ -122.3214243, 47.6050723 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172070, "project_id": 13, "task_id": 369 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3276103, 47.6034876 ], [ -122.3278284, 47.6037229 ], [ -122.3281076, 47.604039 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172243, "project_id": 14, "task_id": 332 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155916, 47.6068881 ], [ -122.3166343, 47.6068948 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172833, "project_id": 14, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3143036, 47.604261 ], [ -122.314317, 47.6035795 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172834, "project_id": 14, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314293, 47.6061063 ], [ -122.3143012, 47.6056121 ] ] } }, +{ "type": "Feature", "properties": { "id": 1172835, "project_id": 14, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142924, 47.6061134 ], [ -122.3153786, 47.6061114 ] ] } }, +{ "type": "Feature", "properties": { "id": 1174072, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275224, 47.6008136 ], [ -122.32704, 47.6008208 ], [ -122.3266886, 47.6008101 ], [ -122.3265243, 47.6008043 ] ] } }, +{ "type": "Feature", "properties": { "id": 1174073, "project_id": 14, "task_id": 155 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316232, 47.6000973 ], [ -122.3161204, 47.6000191 ] ] } }, +{ "type": "Feature", "properties": { "id": 1174074, "project_id": 14, "task_id": 148 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.315253, 47.600095 ], [ -122.3142947, 47.6000924 ] ] } }, +{ "type": "Feature", "properties": { "id": 1174075, "project_id": 14, "task_id": 148 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142892, 47.600101 ], [ -122.3142882, 47.6001486 ], [ -122.3142908, 47.6002108 ], [ -122.3142926, 47.6004576 ], [ -122.3142928, 47.6005816 ], [ -122.3142925, 47.6006676 ], [ -122.3142903, 47.600776 ] ] } }, +{ "type": "Feature", "properties": { "id": 1174076, "project_id": 14, "task_id": 337 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3152348, 47.601614 ], [ -122.3160857, 47.6016149 ], [ -122.3166482, 47.601618 ] ] } }, +{ "type": "Feature", "properties": { "id": 1174077, "project_id": 14, "task_id": 155 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3161104, 47.6002735 ], [ -122.316307, 47.6004024 ], [ -122.3167399, 47.6008045 ], [ -122.3167952, 47.6008567 ] ] } }, +{ "type": "Feature", "properties": { "id": 1174078, "project_id": 14, "task_id": 109 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311454, 47.600088 ], [ -122.3104181, 47.6000883 ] ] } }, +{ "type": "Feature", "properties": { "id": 1174079, "project_id": 14, "task_id": 111 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114787, 47.6000907 ], [ -122.3114822, 47.6007737 ] ] } }, +{ "type": "Feature", "properties": { "id": 1174080, "project_id": 14, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101502, 47.600087 ], [ -122.3091001, 47.6000827 ] ] } }, +{ "type": "Feature", "properties": { "id": 1174081, "project_id": 14, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3091001, 47.6000827 ], [ -122.3090779, 47.6007637 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175571, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3248241, 47.6074187 ], [ -122.3245609, 47.6071534 ], [ -122.3244438, 47.6070232 ], [ -122.3243223, 47.6068956 ], [ -122.3242547, 47.6068229 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175572, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3242547, 47.6068229 ], [ -122.3240315, 47.6069161 ], [ -122.3238132, 47.6070131 ], [ -122.3233733, 47.6072235 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175574, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3234091, 47.6089768 ], [ -122.3232594, 47.6088025 ], [ -122.3230115, 47.6085231 ], [ -122.3228992, 47.6084066 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175575, "project_id": 13, "task_id": 287 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3234335, 47.608978 ], [ -122.3238603, 47.6087934 ], [ -122.3238985, 47.6087832 ], [ -122.3239022, 47.6087816 ], [ -122.3239093, 47.6087786 ], [ -122.324073, 47.6087095 ], [ -122.3242781, 47.6086055 ] ] } }, +{ "type": "Feature", "properties": { "id": 1175577, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3237916, 47.6080268 ], [ -122.3235366, 47.6081413 ], [ -122.3233266, 47.6082277 ], [ -122.3232565, 47.6082589 ], [ -122.3229537, 47.6083856 ], [ -122.3229038, 47.6084046 ] ] } }, +{ "type": "Feature", "properties": { "id": 1176057, "project_id": 14, "task_id": 374 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3146616, 47.6017466 ], [ -122.3144073, 47.6017489 ] ] } }, +{ "type": "Feature", "properties": { "id": 1176058, "project_id": 14, "task_id": 305 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3143217, 47.6026177 ], [ -122.3142977, 47.6022651 ], [ -122.3142684, 47.6017827 ] ] } }, +{ "type": "Feature", "properties": { "id": 1176059, "project_id": 14, "task_id": 214 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3143332, 47.6026274 ], [ -122.3146274, 47.6026248 ], [ -122.3148811, 47.6026277 ] ] } }, +{ "type": "Feature", "properties": { "id": 1176060, "project_id": 14, "task_id": 214 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3143233, 47.6027518 ], [ -122.3144695, 47.6027498 ], [ -122.3145636, 47.6027502 ], [ -122.3148993, 47.6027505 ] ] } }, +{ "type": "Feature", "properties": { "id": 1176061, "project_id": 14, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316677, 47.6027527 ], [ -122.3166525, 47.6027628 ] ] } }, +{ "type": "Feature", "properties": { "id": 1176062, "project_id": 14, "task_id": 331 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155913, 47.6063012 ], [ -122.3155872, 47.6065502 ], [ -122.3155863, 47.6067866 ] ] } }, +{ "type": "Feature", "properties": { "id": 1176063, "project_id": 14, "task_id": 332 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166717, 47.6063019 ], [ -122.316668, 47.6063779 ], [ -122.3166611, 47.6065459 ], [ -122.3166565, 47.6066905 ], [ -122.316656, 47.60679 ] ] } }, +{ "type": "Feature", "properties": { "id": 1176064, "project_id": 14, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3156046, 47.6063003 ], [ -122.3164976, 47.60629 ], [ -122.3166449, 47.6062905 ] ] } }, +{ "type": "Feature", "properties": { "id": 1176065, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3143049, 47.609293 ], [ -122.3144686, 47.6092894 ], [ -122.3148137, 47.6092911 ], [ -122.3153157, 47.6092922 ], [ -122.3153465, 47.6092983 ] ] } }, +{ "type": "Feature", "properties": { "id": 1176066, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142737, 47.609313 ], [ -122.3142658, 47.6102947 ] ] } }, +{ "type": "Feature", "properties": { "id": 1176741, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182316, 47.6017772 ], [ -122.3184502, 47.6017801 ], [ -122.3189029, 47.6017791 ], [ -122.3194282, 47.6017801 ] ] } }, +{ "type": "Feature", "properties": { "id": 1176743, "project_id": 14, "task_id": 18 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195492, 47.5982659 ], [ -122.3195512, 47.59822 ], [ -122.3195492, 47.5980581 ], [ -122.3195471, 47.5977949 ], [ -122.3195471, 47.5977427 ], [ -122.3195494, 47.5975961 ] ] } }, +{ "type": "Feature", "properties": { "id": 1176744, "project_id": 14, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195496, 47.5975913 ], [ -122.3180036, 47.5975869 ], [ -122.3173777, 47.5975871 ] ] } }, +{ "type": "Feature", "properties": { "id": 1177547, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3271552, 47.6046747 ], [ -122.3276325, 47.6052278 ] ] } }, +{ "type": "Feature", "properties": { "id": 1177705, "project_id": 14, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3171253, 47.5982681 ], [ -122.317123, 47.5979202 ], [ -122.3171221, 47.5975817 ] ] } }, +{ "type": "Feature", "properties": { "id": 1177706, "project_id": 14, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3130205, 47.5975901 ], [ -122.3130245, 47.5975811 ], [ -122.313037, 47.5975751 ], [ -122.3135765, 47.5975756 ], [ -122.3143771, 47.5975801 ], [ -122.3152964, 47.5975802 ], [ -122.3171221, 47.5975817 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179403, "project_id": 14, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090848, 47.6017599 ], [ -122.3101574, 47.6017615 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179869, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3269445, 47.6047416 ], [ -122.3260443, 47.6051085 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179870, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265247, 47.6056941 ], [ -122.3260408, 47.6051522 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179871, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3274449, 47.6053333 ], [ -122.327343, 47.6053785 ], [ -122.3272302, 47.6054247 ], [ -122.3270062, 47.6055194 ], [ -122.3265628, 47.6057047 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179872, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236403, 47.6061431 ], [ -122.3237259, 47.6062379 ], [ -122.3240985, 47.6066501 ], [ -122.32415, 47.6067105 ] ] } }, +{ "type": "Feature", "properties": { "id": 1179873, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236207, 47.606141 ], [ -122.323416, 47.6062255 ], [ -122.3231499, 47.6063399 ], [ -122.3229203, 47.6064327 ], [ -122.3227562, 47.6065115 ] ] } }, +{ "type": "Feature", "properties": { "id": 1180217, "project_id": 14, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140987, 47.6027647 ], [ -122.3140973, 47.6034546 ] ] } }, +{ "type": "Feature", "properties": { "id": 1210967, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327006, 47.604503 ], [ -122.3279152, 47.6041341 ] ] } }, +{ "type": "Feature", "properties": { "id": 1210968, "project_id": 13, "task_id": 369 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3274133, 47.603543 ], [ -122.3279189, 47.6040992 ] ] } }, +{ "type": "Feature", "properties": { "id": 1211018, "project_id": 14, "task_id": 18 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197708, 47.5982626 ], [ -122.3197707, 47.5980664 ], [ -122.3197708, 47.5978003 ], [ -122.3197688, 47.5976006 ] ] } }, +{ "type": "Feature", "properties": { "id": 1211019, "project_id": 13, "task_id": 84 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197819, 47.5982715 ], [ -122.3205414, 47.5982748 ], [ -122.3219495, 47.598275 ], [ -122.3223259, 47.5982769 ] ] } }, +{ "type": "Feature", "properties": { "id": 1211020, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223468, 47.5976157 ], [ -122.3223457, 47.5982631 ] ] } }, +{ "type": "Feature", "properties": { "id": 1211021, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223072, 47.5974366 ], [ -122.3223474, 47.5974366 ], [ -122.3223478, 47.5974078 ] ] } }, +{ "type": "Feature", "properties": { "id": 1211022, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3228457, 47.6033089 ], [ -122.3227554, 47.6032201 ], [ -122.3224714, 47.6029052 ], [ -122.3223608, 47.6027793 ] ] } }, +{ "type": "Feature", "properties": { "id": 1216697, "project_id": 14, "task_id": 113 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155972, 47.6091486 ], [ -122.3164238, 47.6091583 ], [ -122.3166247, 47.6091577 ] ] } }, +{ "type": "Feature", "properties": { "id": 1216702, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206333, 47.6063367 ], [ -122.3206343, 47.6062938 ] ] } }, +{ "type": "Feature", "properties": { "id": 1216703, "project_id": 14, "task_id": 389 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182052, 47.6062892 ], [ -122.3183663, 47.6062861 ], [ -122.3185367, 47.6062842 ], [ -122.318682, 47.6062828 ], [ -122.3187691, 47.6062825 ], [ -122.3192898, 47.6062904 ] ] } }, +{ "type": "Feature", "properties": { "id": 1216704, "project_id": 14, "task_id": 325 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169651, 47.6062854 ], [ -122.3170212, 47.6062865 ], [ -122.3171074, 47.6062859 ], [ -122.3171675, 47.6062857 ], [ -122.3172443, 47.606284 ], [ -122.3173437, 47.6062837 ], [ -122.3174583, 47.6062856 ], [ -122.3180241, 47.6062931 ] ] } }, +{ "type": "Feature", "properties": { "id": 1216705, "project_id": 14, "task_id": 282 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169236, 47.607504 ], [ -122.3169231, 47.6071248 ], [ -122.316931, 47.6069245 ] ] } }, +{ "type": "Feature", "properties": { "id": 1216706, "project_id": 14, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169236, 47.607504 ], [ -122.3169245, 47.6075819 ], [ -122.3169222, 47.6079214 ], [ -122.3169211, 47.6079673 ] ] } }, +{ "type": "Feature", "properties": { "id": 1216707, "project_id": 14, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166375, 47.6075039 ], [ -122.316637, 47.6078407 ], [ -122.3166267, 47.6079643 ] ] } }, +{ "type": "Feature", "properties": { "id": 1216708, "project_id": 14, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155887, 47.6075082 ], [ -122.315582, 47.6079491 ] ] } }, +{ "type": "Feature", "properties": { "id": 1216709, "project_id": 14, "task_id": 283 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166267, 47.6079643 ], [ -122.3161647, 47.607969 ], [ -122.3157762, 47.6079684 ], [ -122.3156285, 47.6079743 ] ] } }, +{ "type": "Feature", "properties": { "id": 1216710, "project_id": 14, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142933, 47.6062858 ], [ -122.3153753, 47.6062926 ] ] } }, +{ "type": "Feature", "properties": { "id": 1216711, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129684, 47.6081122 ], [ -122.313514, 47.6081121 ], [ -122.3140336, 47.6081129 ] ] } }, +{ "type": "Feature", "properties": { "id": 1216712, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140537, 47.6091288 ], [ -122.3140577, 47.6081174 ] ] } }, +{ "type": "Feature", "properties": { "id": 1216713, "project_id": 14, "task_id": 51 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129443, 47.6062844 ], [ -122.3129776, 47.6067866 ], [ -122.3129709, 47.6077194 ], [ -122.3129662, 47.60795 ] ] } }, +{ "type": "Feature", "properties": { "id": 1216714, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140386, 47.6079623 ], [ -122.3135134, 47.6079607 ], [ -122.3129665, 47.6079606 ] ] } }, +{ "type": "Feature", "properties": { "id": 1216715, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127589, 47.6081106 ], [ -122.3116863, 47.6081049 ] ] } }, +{ "type": "Feature", "properties": { "id": 1216717, "project_id": 14, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116683, 47.6062856 ], [ -122.3116671, 47.6066854 ], [ -122.3116565, 47.6079392 ] ] } }, +{ "type": "Feature", "properties": { "id": 1216718, "project_id": 14, "task_id": 136 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114207, 47.6081037 ], [ -122.3108968, 47.6081009 ], [ -122.310593, 47.608099 ], [ -122.3105431, 47.6080995 ], [ -122.3103523, 47.6081034 ] ] } }, +{ "type": "Feature", "properties": { "id": 1216720, "project_id": 14, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103591, 47.6062786 ], [ -122.3109361, 47.6062797 ], [ -122.3114665, 47.6062891 ] ] } }, +{ "type": "Feature", "properties": { "id": 1216721, "project_id": 14, "task_id": 6 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101508, 47.6079441 ], [ -122.3099437, 47.6079435 ], [ -122.30964, 47.6079459 ], [ -122.3090881, 47.6079397 ] ] } }, +{ "type": "Feature", "properties": { "id": 1216723, "project_id": 14, "task_id": 8 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088385, 47.606266 ], [ -122.3088314, 47.6079242 ] ] } }, +{ "type": "Feature", "properties": { "id": 1216724, "project_id": 14, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077649, 47.6062606 ], [ -122.307744, 47.607884 ] ] } }, +{ "type": "Feature", "properties": { "id": 1218497, "project_id": 14, "task_id": 18 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3191646, 47.5959922 ], [ -122.3191837, 47.5961671 ], [ -122.3192214, 47.5963666 ], [ -122.3192523, 47.5964386 ], [ -122.3193173, 47.5965727 ], [ -122.3194096, 47.596734 ], [ -122.3194784, 47.5968692 ], [ -122.3195477, 47.5970081 ], [ -122.3195637, 47.5971159 ], [ -122.3195577, 47.5974202 ] ] } }, +{ "type": "Feature", "properties": { "id": 1219162, "project_id": 14, "task_id": 311 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169437, 47.6035807 ], [ -122.3171247, 47.6035809 ], [ -122.3177757, 47.6035766 ], [ -122.3180128, 47.6035804 ] ] } }, +{ "type": "Feature", "properties": { "id": 1219163, "project_id": 14, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169329, 47.6042799 ], [ -122.3177762, 47.6042852 ], [ -122.318018, 47.6042854 ] ] } }, +{ "type": "Feature", "properties": { "id": 1219164, "project_id": 14, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180231, 47.603587 ], [ -122.3180172, 47.6042786 ] ] } }, +{ "type": "Feature", "properties": { "id": 1219166, "project_id": 14, "task_id": 337 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31692, 47.6017886 ], [ -122.3169351, 47.6023884 ], [ -122.3169397, 47.6026193 ] ] } }, +{ "type": "Feature", "properties": { "id": 1219167, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193313, 47.6044417 ], [ -122.3193389, 47.6047883 ], [ -122.319332, 47.6051319 ] ] } }, +{ "type": "Feature", "properties": { "id": 1219168, "project_id": 14, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169403, 47.6051331 ], [ -122.3180013, 47.6051332 ] ] } }, +{ "type": "Feature", "properties": { "id": 1219169, "project_id": 14, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316938, 47.6057855 ], [ -122.316937, 47.6058874 ], [ -122.3169394, 47.6060336 ], [ -122.3169385, 47.6060562 ], [ -122.3169343, 47.6061141 ], [ -122.3169447, 47.6061244 ], [ -122.3169682, 47.6061344 ] ] } }, +{ "type": "Feature", "properties": { "id": 1219170, "project_id": 14, "task_id": 325 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169682, 47.6061344 ], [ -122.3169989, 47.6061349 ], [ -122.3170837, 47.6061363 ], [ -122.3171757, 47.6061364 ], [ -122.3171808, 47.6061364 ], [ -122.3172355, 47.6061365 ], [ -122.3174401, 47.606141 ], [ -122.31778, 47.6061518 ], [ -122.3177864, 47.6061517 ], [ -122.3180204, 47.606149 ] ] } }, +{ "type": "Feature", "properties": { "id": 1219552, "project_id": 14, "task_id": 38 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3160239, 47.5959308 ], [ -122.3160424, 47.5959728 ], [ -122.3160399, 47.5965387 ], [ -122.3160376, 47.5965659 ], [ -122.3160306, 47.5965891 ], [ -122.3160164, 47.5966114 ], [ -122.3159934, 47.5966357 ], [ -122.3159621, 47.5966588 ], [ -122.3159299, 47.5966777 ], [ -122.31589, 47.5966943 ], [ -122.3158021, 47.5967087 ], [ -122.3158024, 47.5967505 ], [ -122.3156985, 47.5967498 ], [ -122.3154401, 47.5967501 ], [ -122.3149893, 47.596749 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220020, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3217482, 47.6037958 ], [ -122.3217757, 47.603783 ], [ -122.3218174, 47.6037433 ], [ -122.3221325, 47.6036106 ], [ -122.3226368, 47.6033999 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220021, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3231767, 47.6053444 ], [ -122.3233177, 47.60529 ], [ -122.3237402, 47.6051095 ], [ -122.324029, 47.6049771 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220022, "project_id": 13, "task_id": 149 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322769, 47.603535 ], [ -122.3231614, 47.6039707 ], [ -122.3238934, 47.6047664 ], [ -122.3239307, 47.6048046 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220023, "project_id": 13, "task_id": 140 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321855, 47.6039077 ], [ -122.3227593, 47.6035274 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220024, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3230356, 47.6051942 ], [ -122.3232863, 47.6050947 ], [ -122.3234904, 47.6050097 ], [ -122.3235726, 47.6049731 ], [ -122.3236782, 47.6049269 ], [ -122.323922, 47.6048299 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220025, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249433, 47.6056074 ], [ -122.325434, 47.6061665 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220027, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3263517, 47.6057614 ], [ -122.3258714, 47.6052132 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220028, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249384, 47.6055828 ], [ -122.3250925, 47.6055132 ], [ -122.3258288, 47.6051977 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220029, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238162, 47.6060484 ], [ -122.3240901, 47.605934 ], [ -122.3245075, 47.6057551 ], [ -122.3246955, 47.6056758 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220030, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252312, 47.6062623 ], [ -122.3252449, 47.6062335 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220031, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.32611, 47.6068863 ], [ -122.3259956, 47.6067455 ], [ -122.325791, 47.6065333 ], [ -122.3255831, 47.6063223 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220032, "project_id": 13, "task_id": 60 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3270257, 47.6065014 ], [ -122.3264862, 47.6059385 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220033, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325591, 47.6062987 ], [ -122.3257508, 47.6062325 ], [ -122.3263, 47.6060035 ], [ -122.3264619, 47.605932 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220034, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325001, 47.6073552 ], [ -122.3251923, 47.6072693 ], [ -122.3254283, 47.6071664 ], [ -122.3255247, 47.6071245 ], [ -122.3257429, 47.607033 ], [ -122.3257585, 47.6070277 ], [ -122.3259077, 47.6069661 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220035, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251136, 47.6074712 ], [ -122.3252512, 47.6074123 ], [ -122.3258144, 47.6071871 ], [ -122.3260305, 47.6070947 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220037, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260389, 47.607102 ], [ -122.3265495, 47.6076687 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220372, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265155, 47.6009515 ], [ -122.3266872, 47.6009587 ], [ -122.3275349, 47.600953 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220373, "project_id": 14, "task_id": 152 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173493, 47.5993215 ], [ -122.3173484, 47.5996223 ], [ -122.3173465, 47.5999751 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220374, "project_id": 13, "task_id": 6 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182961, 47.5999813 ], [ -122.3183659, 47.5999808 ], [ -122.3184212, 47.5999771 ], [ -122.3184612, 47.599976 ], [ -122.3185066, 47.5999808 ], [ -122.319017, 47.6000965 ], [ -122.3191543, 47.6001298 ], [ -122.3192029, 47.600146 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220375, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3196959, 47.6016097 ], [ -122.3199784, 47.6015996 ], [ -122.3202136, 47.6016015 ], [ -122.3204468, 47.6015883 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220376, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319524, 47.6026219 ], [ -122.3195221, 47.602309 ], [ -122.3195976, 47.6022166 ], [ -122.3196156, 47.6021945 ], [ -122.3196528, 47.6021281 ], [ -122.3196706, 47.6020679 ], [ -122.3196733, 47.6020096 ], [ -122.3196707, 47.6018648 ], [ -122.3196629, 47.6017914 ] ] } }, +{ "type": "Feature", "properties": { "id": 1220377, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206075, 47.601874 ], [ -122.3206061, 47.6021969 ], [ -122.3206148, 47.6026354 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221032, "project_id": 13, "task_id": 265 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209164, 47.6043047 ], [ -122.3209122, 47.6043418 ], [ -122.3209116, 47.6043764 ], [ -122.3209109, 47.6043939 ], [ -122.3209078, 47.6044534 ], [ -122.3209034, 47.6044831 ], [ -122.3208994, 47.6045054 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221033, "project_id": 13, "task_id": 265 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320621, 47.6041891 ], [ -122.3206355, 47.6042584 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221034, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3221983, 47.6045695 ], [ -122.3214823, 47.6048619 ], [ -122.3213199, 47.6049314 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221035, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3216598, 47.6039843 ], [ -122.3214437, 47.6040784 ], [ -122.3211879, 47.604188 ], [ -122.3209911, 47.6042727 ], [ -122.3209164, 47.6043047 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221036, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3217224, 47.6057417 ], [ -122.3211996, 47.605171 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221038, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206094, 47.6045393 ], [ -122.3205956, 47.6045133 ], [ -122.3205814, 47.6044949 ], [ -122.3205718, 47.6044859 ], [ -122.3205634, 47.604478 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221039, "project_id": 13, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195612, 47.6044282 ], [ -122.3197571, 47.6044299 ], [ -122.3200039, 47.6044318 ], [ -122.320023, 47.6044089 ], [ -122.3201279, 47.6044103 ], [ -122.3201574, 47.6044339 ], [ -122.3204186, 47.604431 ], [ -122.320456, 47.6044261 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221040, "project_id": 13, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195249, 47.604451 ], [ -122.3195103, 47.604792 ], [ -122.3195132, 47.6049066 ], [ -122.3195319, 47.6049319 ], [ -122.3195235, 47.6051148 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221042, "project_id": 13, "task_id": 50 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320627, 47.6061245 ], [ -122.3206239, 47.6055866 ], [ -122.3206179, 47.6053707 ], [ -122.3206164, 47.6052905 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221043, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208922, 47.6063017 ], [ -122.320908, 47.6062818 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221045, "project_id": 13, "task_id": 159 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218595, 47.6058976 ], [ -122.3219654, 47.6060055 ], [ -122.3220223, 47.6060674 ], [ -122.3220825, 47.606134 ], [ -122.3221233, 47.6061784 ], [ -122.322276, 47.6063535 ], [ -122.3223325, 47.6064166 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221046, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218102, 47.6058969 ], [ -122.3212611, 47.6061318 ], [ -122.3211125, 47.6061936 ], [ -122.3209632, 47.6062513 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221047, "project_id": 14, "task_id": 180 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209203, 47.6080707 ], [ -122.320918, 47.6077919 ], [ -122.3209061, 47.6075607 ], [ -122.3209152, 47.6073083 ], [ -122.32093, 47.6072626 ], [ -122.3208785, 47.6072894 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221048, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214137, 47.6070759 ], [ -122.3219316, 47.6076415 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221049, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214047, 47.6070624 ], [ -122.32093, 47.6072626 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221050, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3212772, 47.6069188 ], [ -122.3211028, 47.6069958 ], [ -122.3209477, 47.6070615 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221051, "project_id": 13, "task_id": 51 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3212582, 47.6068973 ], [ -122.3212363, 47.6068744 ], [ -122.3210816, 47.6067127 ], [ -122.3210797, 47.6067107 ], [ -122.3209656, 47.6065846 ], [ -122.3209093, 47.6065418 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221053, "project_id": 13, "task_id": 51 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208978, 47.606556 ], [ -122.3209002, 47.6070431 ] ] } }, +{ "type": "Feature", "properties": { "id": 1221054, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226064, 47.6083656 ], [ -122.3224888, 47.6082384 ], [ -122.3224668, 47.6082121 ], [ -122.3223179, 47.6080413 ], [ -122.3222835, 47.6080034 ], [ -122.322089, 47.6077907 ], [ -122.3220788, 47.607784 ], [ -122.3220682, 47.6077808 ] ] } }, +{ "type": "Feature", "properties": { "id": 1223052, "project_id": 14, "task_id": 294 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116957, 47.6017842 ], [ -122.3116956, 47.6019262 ], [ -122.3117007, 47.602353 ], [ -122.3117018, 47.6026259 ] ] } }, +{ "type": "Feature", "properties": { "id": 1223053, "project_id": 14, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127661, 47.6017662 ], [ -122.311705, 47.6017715 ] ] } }, +{ "type": "Feature", "properties": { "id": 1223054, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3111523, 47.6026238 ], [ -122.3107602, 47.6026252 ], [ -122.3103724, 47.6026226 ] ] } }, +{ "type": "Feature", "properties": { "id": 1223055, "project_id": 14, "task_id": 291 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3111523, 47.6026238 ], [ -122.3114661, 47.6026237 ] ] } }, +{ "type": "Feature", "properties": { "id": 1223056, "project_id": 14, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127733, 47.6016383 ], [ -122.3117006, 47.6016376 ] ] } }, +{ "type": "Feature", "properties": { "id": 1223057, "project_id": 14, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127687, 47.6009279 ], [ -122.3116996, 47.6009267 ] ] } }, +{ "type": "Feature", "properties": { "id": 1223058, "project_id": 14, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116996, 47.6009267 ], [ -122.3116966, 47.6012723 ], [ -122.3116893, 47.6016188 ] ] } }, +{ "type": "Feature", "properties": { "id": 1223059, "project_id": 14, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31167, 47.6060957 ], [ -122.3116832, 47.6044121 ] ] } }, +{ "type": "Feature", "properties": { "id": 1223060, "project_id": 14, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310386, 47.6044051 ], [ -122.3103853, 47.605238 ], [ -122.3103833, 47.6056592 ], [ -122.3103869, 47.60584 ], [ -122.3103836, 47.6059394 ], [ -122.3103795, 47.6059925 ], [ -122.3103756, 47.6060933 ] ] } }, +{ "type": "Feature", "properties": { "id": 1223061, "project_id": 14, "task_id": 287 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114164, 47.604279 ], [ -122.3114759, 47.6042799 ] ] } }, +{ "type": "Feature", "properties": { "id": 1224082, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262002, 47.5999598 ], [ -122.3260182, 47.5999612 ], [ -122.3252186, 47.5999574 ] ] } }, +{ "type": "Feature", "properties": { "id": 1224083, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252107, 47.5993013 ], [ -122.3251816, 47.5993376 ] ] } }, +{ "type": "Feature", "properties": { "id": 1224084, "project_id": 13, "task_id": 250 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262728, 47.5990901 ], [ -122.3252203, 47.5990976 ] ] } }, +{ "type": "Feature", "properties": { "id": 1224085, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238834, 47.5982376 ], [ -122.3238844, 47.5979398 ], [ -122.3238852, 47.5976163 ] ] } }, +{ "type": "Feature", "properties": { "id": 1225999, "project_id": 14, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195314, 47.5990694 ], [ -122.3195316, 47.5987705 ], [ -122.3195343, 47.5984223 ] ] } }, +{ "type": "Feature", "properties": { "id": 1226000, "project_id": 14, "task_id": 62 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173609, 47.5990837 ], [ -122.3173552, 47.5984374 ] ] } }, +{ "type": "Feature", "properties": { "id": 1226001, "project_id": 14, "task_id": 153 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194942, 47.59907 ], [ -122.3194236, 47.59907 ], [ -122.3191503, 47.59907 ], [ -122.3189953, 47.5990707 ], [ -122.31845, 47.5990766 ], [ -122.3177612, 47.5990822 ], [ -122.3173951, 47.5990837 ] ] } }, +{ "type": "Feature", "properties": { "id": 1226002, "project_id": 14, "task_id": 152 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3170639, 47.5993132 ], [ -122.3170719, 47.5999318 ], [ -122.3170622, 47.5999416 ] ] } }, +{ "type": "Feature", "properties": { "id": 1226003, "project_id": 14, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142931, 47.5994202 ], [ -122.3142931, 47.5994846 ], [ -122.3142847, 47.5999293 ] ] } }, +{ "type": "Feature", "properties": { "id": 1226004, "project_id": 14, "task_id": 148 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155466, 47.5999429 ], [ -122.3142969, 47.5999419 ] ] } }, +{ "type": "Feature", "properties": { "id": 1226006, "project_id": 14, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142931, 47.5994202 ], [ -122.3143889, 47.5994629 ], [ -122.3145405, 47.5995233 ], [ -122.3148991, 47.5996477 ], [ -122.3150164, 47.5996882 ], [ -122.3151825, 47.5997541 ], [ -122.3153028, 47.599805 ], [ -122.3154227, 47.5998586 ], [ -122.3155677, 47.5999291 ] ] } }, +{ "type": "Feature", "properties": { "id": 1226007, "project_id": 14, "task_id": 105 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3117149, 47.5993087 ], [ -122.3139419, 47.599298 ], [ -122.3139665, 47.5992981 ] ] } }, +{ "type": "Feature", "properties": { "id": 1226008, "project_id": 14, "task_id": 98 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3139871, 47.5999397 ], [ -122.3132133, 47.5999361 ], [ -122.3129455, 47.5999364 ], [ -122.3116978, 47.5999345 ] ] } }, +{ "type": "Feature", "properties": { "id": 1226009, "project_id": 14, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140209, 47.5994014 ], [ -122.3140184, 47.599479 ], [ -122.3140094, 47.5996777 ], [ -122.3140066, 47.599824 ], [ -122.3140084, 47.5999272 ] ] } }, +{ "type": "Feature", "properties": { "id": 1226013, "project_id": 14, "task_id": 205 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101774, 47.5991609 ], [ -122.3091003, 47.5991643 ] ] } }, +{ "type": "Feature", "properties": { "id": 1226014, "project_id": 14, "task_id": 190 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3104007, 47.5993155 ], [ -122.311474, 47.5993121 ] ] } }, +{ "type": "Feature", "properties": { "id": 1226015, "project_id": 14, "task_id": 109 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114767, 47.5999347 ], [ -122.3104063, 47.5999362 ] ] } }, +{ "type": "Feature", "properties": { "id": 1226016, "project_id": 14, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101573, 47.5999345 ], [ -122.3091063, 47.5999312 ] ] } }, +{ "type": "Feature", "properties": { "id": 1226017, "project_id": 14, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.307763, 47.599329 ], [ -122.308855, 47.5993214 ] ] } }, +{ "type": "Feature", "properties": { "id": 1226020, "project_id": 14, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088747, 47.6000874 ], [ -122.308868, 47.600765 ] ] } }, +{ "type": "Feature", "properties": { "id": 1226021, "project_id": 14, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088667, 47.599139 ], [ -122.3088634, 47.5988547 ] ] } }, +{ "type": "Feature", "properties": { "id": 1226024, "project_id": 14, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088525, 47.5991542 ], [ -122.3078008, 47.5991575 ] ] } }, +{ "type": "Feature", "properties": { "id": 1230433, "project_id": 14, "task_id": 305 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140937, 47.6026137 ], [ -122.314076, 47.6022718 ], [ -122.3140572, 47.601785 ] ] } }, +{ "type": "Feature", "properties": { "id": 1230434, "project_id": 14, "task_id": 212 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.313009, 47.601615 ], [ -122.3140022, 47.6016159 ] ] } }, +{ "type": "Feature", "properties": { "id": 1230435, "project_id": 14, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3139967, 47.6009295 ], [ -122.3129987, 47.6009282 ] ] } }, +{ "type": "Feature", "properties": { "id": 1230436, "project_id": 14, "task_id": 209 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140677, 47.6061079 ], [ -122.3137541, 47.606102 ], [ -122.313511, 47.6060978 ], [ -122.3130195, 47.6060966 ], [ -122.3129824, 47.6060971 ] ] } }, +{ "type": "Feature", "properties": { "id": 1230437, "project_id": 14, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140764, 47.6061078 ], [ -122.3140746, 47.6058544 ], [ -122.314072, 47.605678 ], [ -122.3140719, 47.6056088 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231838, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225808, 47.5973964 ], [ -122.3225811, 47.5970504 ], [ -122.3225852, 47.5967447 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231839, "project_id": 14, "task_id": 38 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3158445, 47.5959545 ], [ -122.3158441, 47.596119 ], [ -122.315842, 47.5964947 ], [ -122.3158413, 47.5965239 ], [ -122.3158407, 47.5965449 ], [ -122.3158406, 47.5965636 ], [ -122.3158353, 47.5965788 ], [ -122.3158234, 47.5965897 ], [ -122.3158028, 47.5965971 ], [ -122.3157714, 47.5965992 ], [ -122.3156614, 47.5966003 ], [ -122.3154888, 47.5965995 ], [ -122.3149377, 47.5965966 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231841, "project_id": 14, "task_id": 101 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3139895, 47.5959591 ], [ -122.3139895, 47.5962219 ], [ -122.3139803, 47.5965235 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231883, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3229496, 47.6054207 ], [ -122.3220844, 47.6057852 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231884, "project_id": 13, "task_id": 283 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3234561, 47.6059932 ], [ -122.3230115, 47.6061769 ], [ -122.3227827, 47.6062766 ], [ -122.3226575, 47.606327 ], [ -122.322598, 47.6063381 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231885, "project_id": 13, "task_id": 283 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3234629, 47.6059797 ], [ -122.323341, 47.6058393 ], [ -122.3232829, 47.6057749 ], [ -122.3232481, 47.6057343 ], [ -122.3232023, 47.6056839 ], [ -122.3231604, 47.6056382 ], [ -122.3229842, 47.6054468 ], [ -122.3229686, 47.6054256 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231886, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219206, 47.6056566 ], [ -122.3214155, 47.6050952 ] ] } }, +{ "type": "Feature", "properties": { "id": 1231890, "project_id": 13, "task_id": 451 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3276041, 47.6034773 ], [ -122.3284939, 47.6030976 ] ] } }, +{ "type": "Feature", "properties": { "id": 1232099, "project_id": 14, "task_id": 282 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166375, 47.6075039 ], [ -122.3166361, 47.6071498 ], [ -122.316641, 47.6069174 ] ] } }, +{ "type": "Feature", "properties": { "id": 1232100, "project_id": 14, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155916, 47.6068881 ], [ -122.3155923, 47.6069072 ], [ -122.3155827, 47.6073639 ] ] } }, +{ "type": "Feature", "properties": { "id": 1232701, "project_id": 14, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166425, 47.6061136 ], [ -122.3155921, 47.606108 ] ] } }, +{ "type": "Feature", "properties": { "id": 1232702, "project_id": 14, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166612, 47.6061079 ], [ -122.31666, 47.6060328 ], [ -122.3166569, 47.605794 ], [ -122.3166589, 47.6056375 ], [ -122.3166465, 47.6056215 ] ] } }, +{ "type": "Feature", "properties": { "id": 1232703, "project_id": 14, "task_id": 392 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166547, 47.6054871 ], [ -122.3166528, 47.6052704 ] ] } }, +{ "type": "Feature", "properties": { "id": 1232704, "project_id": 14, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316638, 47.6044152 ], [ -122.3166527, 47.6046215 ], [ -122.3166558, 47.6049659 ], [ -122.316652, 47.6051223 ] ] } }, +{ "type": "Feature", "properties": { "id": 1232705, "project_id": 14, "task_id": 311 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316639, 47.6042731 ], [ -122.3166521, 47.6035827 ] ] } }, +{ "type": "Feature", "properties": { "id": 1232706, "project_id": 14, "task_id": 258 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3143076, 47.6044232 ], [ -122.314305, 47.605509 ] ] } }, +{ "type": "Feature", "properties": { "id": 1232707, "project_id": 14, "task_id": 334 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153763, 47.6055165 ], [ -122.3150857, 47.6055166 ], [ -122.314305, 47.605509 ] ] } }, +{ "type": "Feature", "properties": { "id": 1232708, "project_id": 14, "task_id": 334 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155915, 47.6055167 ], [ -122.3158991, 47.605523 ], [ -122.3165452, 47.6055215 ], [ -122.3166537, 47.6055187 ] ] } }, +{ "type": "Feature", "properties": { "id": 1232709, "project_id": 14, "task_id": 334 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153841, 47.6056263 ], [ -122.3151299, 47.6056249 ], [ -122.315111, 47.6056114 ], [ -122.3150259, 47.6056125 ], [ -122.3144633, 47.6056107 ], [ -122.3143012, 47.6056121 ] ] } }, +{ "type": "Feature", "properties": { "id": 1233854, "project_id": 14, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088647, 47.6017642 ], [ -122.308315, 47.6017623 ], [ -122.3077808, 47.6017525 ] ] } }, +{ "type": "Feature", "properties": { "id": 1233958, "project_id": 13, "task_id": 246 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265335, 47.6001188 ], [ -122.3275266, 47.6001074 ], [ -122.3275381, 47.6001073 ] ] } }, +{ "type": "Feature", "properties": { "id": 1233959, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192466, 47.6008559 ], [ -122.3192419, 47.6008427 ] ] } }, +{ "type": "Feature", "properties": { "id": 1233960, "project_id": 14, "task_id": 231 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3157874, 47.6000943 ], [ -122.3158035, 47.6000937 ], [ -122.315818, 47.6000944 ], [ -122.31583, 47.600096 ], [ -122.3158512, 47.6001034 ], [ -122.3158789, 47.6001211 ] ] } }, +{ "type": "Feature", "properties": { "id": 1233961, "project_id": 14, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142893, 47.6009221 ], [ -122.3142881, 47.6011228 ], [ -122.3142875, 47.6012832 ], [ -122.3142869, 47.6014257 ], [ -122.3142899, 47.6015427 ], [ -122.3143153, 47.601569 ] ] } }, +{ "type": "Feature", "properties": { "id": 1233962, "project_id": 14, "task_id": 374 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3147435, 47.6016116 ], [ -122.3143957, 47.6016048 ] ] } }, +{ "type": "Feature", "properties": { "id": 1233963, "project_id": 14, "task_id": 337 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166678, 47.6016163 ], [ -122.3166791, 47.6014846 ], [ -122.3166819, 47.6013743 ], [ -122.3166899, 47.6012828 ], [ -122.316695, 47.6012485 ], [ -122.3167256, 47.6011556 ], [ -122.3167608, 47.601065 ], [ -122.3167803, 47.6010098 ] ] } }, +{ "type": "Feature", "properties": { "id": 1233964, "project_id": 14, "task_id": 98 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116995, 47.6000895 ], [ -122.312942, 47.6000898 ], [ -122.3131185, 47.6000913 ], [ -122.3136026, 47.600092 ], [ -122.314005, 47.6000903 ] ] } }, +{ "type": "Feature", "properties": { "id": 1233965, "project_id": 14, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.312778, 47.6007775 ], [ -122.3117088, 47.6007783 ] ] } }, +{ "type": "Feature", "properties": { "id": 1233966, "project_id": 14, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3139795, 47.6007744 ], [ -122.3136779, 47.6007782 ], [ -122.313, 47.6007787 ] ] } }, +{ "type": "Feature", "properties": { "id": 1233967, "project_id": 14, "task_id": 148 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140056, 47.6000979 ], [ -122.3140055, 47.6002281 ], [ -122.314007, 47.6004775 ], [ -122.3140028, 47.600764 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235524, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275732, 47.6054519 ], [ -122.3272077, 47.6056014 ], [ -122.3270994, 47.6056503 ], [ -122.326912, 47.605732 ], [ -122.3266778, 47.6058356 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235525, "project_id": 13, "task_id": 60 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3271836, 47.6063911 ], [ -122.3266726, 47.6058582 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235526, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249231, 47.6075582 ], [ -122.3247861, 47.6076155 ], [ -122.3244492, 47.6077554 ], [ -122.3243883, 47.6077803 ], [ -122.3241871, 47.6078653 ], [ -122.3240111, 47.6079369 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235528, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3254415, 47.608132 ], [ -122.3253211, 47.6079938 ], [ -122.3252037, 47.6078627 ], [ -122.3249672, 47.6076017 ], [ -122.3249388, 47.6075707 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235529, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3248043, 47.6074263 ], [ -122.3246739, 47.6074841 ], [ -122.3243297, 47.6076277 ], [ -122.324117, 47.6077154 ], [ -122.3239086, 47.6078052 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235530, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236727, 47.6079026 ], [ -122.3234096, 47.6080076 ], [ -122.3232075, 47.6080927 ], [ -122.3227784, 47.6082822 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235531, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3231375, 47.6073152 ], [ -122.3230917, 47.6073248 ], [ -122.3226733, 47.6075036 ], [ -122.3222771, 47.6076741 ], [ -122.3222505, 47.607686 ] ] } }, +{ "type": "Feature", "properties": { "id": 1235532, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3227784, 47.6082822 ], [ -122.3226184, 47.6081087 ], [ -122.3224691, 47.6079552 ], [ -122.3222462, 47.6077074 ], [ -122.3222377, 47.607697 ] ] } }, +{ "type": "Feature", "properties": { "id": 1236005, "project_id": 14, "task_id": 230 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3150328, 47.6017634 ], [ -122.3150234, 47.6026251 ] ] } }, +{ "type": "Feature", "properties": { "id": 1236006, "project_id": 14, "task_id": 337 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166583, 47.6017769 ], [ -122.316662, 47.6026201 ] ] } }, +{ "type": "Feature", "properties": { "id": 1236008, "project_id": 14, "task_id": 337 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3150333, 47.6017463 ], [ -122.315897, 47.6017513 ], [ -122.3166457, 47.6017652 ] ] } }, +{ "type": "Feature", "properties": { "id": 1236009, "project_id": 14, "task_id": 230 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3148831, 47.6017473 ], [ -122.3148808, 47.6021768 ], [ -122.3148806, 47.6023784 ], [ -122.3148811, 47.6026277 ] ] } }, +{ "type": "Feature", "properties": { "id": 1236010, "project_id": 14, "task_id": 213 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142902, 47.6027675 ], [ -122.3143065, 47.6034491 ] ] } }, +{ "type": "Feature", "properties": { "id": 1236011, "project_id": 14, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3143075, 47.6034562 ], [ -122.3154785, 47.6034594 ], [ -122.3166273, 47.6034582 ] ] } }, +{ "type": "Feature", "properties": { "id": 1236013, "project_id": 14, "task_id": 332 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155863, 47.6067866 ], [ -122.316656, 47.60679 ] ] } }, +{ "type": "Feature", "properties": { "id": 1236015, "project_id": 14, "task_id": 58 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166636, 47.609319 ], [ -122.3166702, 47.6094749 ], [ -122.3166655, 47.6103137 ] ] } }, +{ "type": "Feature", "properties": { "id": 1236016, "project_id": 14, "task_id": 113 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3156048, 47.6092937 ], [ -122.3166358, 47.6093063 ] ] } }, +{ "type": "Feature", "properties": { "id": 1236677, "project_id": 13, "task_id": 46 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193142, 47.6010711 ], [ -122.3193273, 47.601102 ], [ -122.3194261, 47.6011526 ], [ -122.3194682, 47.6012939 ], [ -122.3194381, 47.601305 ], [ -122.3193993, 47.6013325 ], [ -122.3194216, 47.6014072 ], [ -122.3194304, 47.6014426 ], [ -122.3194359, 47.6015634 ] ] } }, +{ "type": "Feature", "properties": { "id": 1236678, "project_id": 13, "task_id": 138 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3186006, 47.6022884 ], [ -122.3189173, 47.6026037 ] ] } }, +{ "type": "Feature", "properties": { "id": 1236679, "project_id": 14, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173671, 47.5975964 ], [ -122.3173593, 47.5979215 ], [ -122.3173593, 47.5982708 ] ] } }, +{ "type": "Feature", "properties": { "id": 1237636, "project_id": 14, "task_id": 345 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169458, 47.6016177 ], [ -122.3175587, 47.6016207 ] ] } }, +{ "type": "Feature", "properties": { "id": 1237637, "project_id": 14, "task_id": 262 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169456, 47.6016077 ], [ -122.3169544, 47.6014562 ], [ -122.3169684, 47.6013488 ], [ -122.3170062, 47.601223 ], [ -122.3170307, 47.6011331 ], [ -122.317036, 47.6011057 ], [ -122.3170422, 47.6010802 ] ] } }, +{ "type": "Feature", "properties": { "id": 1237692, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236509, 47.5976179 ], [ -122.32365, 47.5979378 ], [ -122.3236506, 47.5982316 ] ] } }, +{ "type": "Feature", "properties": { "id": 1237693, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235944, 47.5982803 ], [ -122.3227825, 47.5982801 ], [ -122.3225782, 47.5982798 ] ] } }, +{ "type": "Feature", "properties": { "id": 1237745, "project_id": 14, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3091076, 47.6016056 ], [ -122.3090893, 47.6012592 ], [ -122.3090939, 47.6009233 ] ] } }, +{ "type": "Feature", "properties": { "id": 1237746, "project_id": 14, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3091076, 47.6016056 ], [ -122.3101592, 47.6016129 ] ] } }, +{ "type": "Feature", "properties": { "id": 1239363, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3111579, 47.6027443 ], [ -122.310704, 47.6027441 ], [ -122.3103387, 47.6027423 ] ] } }, +{ "type": "Feature", "properties": { "id": 1239804, "project_id": 13, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3269628, 47.6047475 ], [ -122.3274476, 47.6052982 ] ] } }, +{ "type": "Feature", "properties": { "id": 1239805, "project_id": 13, "task_id": 159 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321599, 47.6069692 ], [ -122.322474, 47.6066287 ] ] } }, +{ "type": "Feature", "properties": { "id": 1239806, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3215687, 47.6069821 ], [ -122.3220995, 47.6075722 ] ] } }, +{ "type": "Feature", "properties": { "id": 1240008, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140464, 47.6093067 ], [ -122.314047, 47.6095652 ], [ -122.3140417, 47.6098607 ], [ -122.3140452, 47.6102784 ] ] } }, +{ "type": "Feature", "properties": { "id": 1240033, "project_id": 14, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140888, 47.6042879 ], [ -122.3140936, 47.6035788 ] ] } }, +{ "type": "Feature", "properties": { "id": 1240186, "project_id": 14, "task_id": 46 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088413, 47.6060965 ], [ -122.3084188, 47.606082 ], [ -122.307771, 47.6060875 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278687, "project_id": 14, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169422, 47.6079842 ], [ -122.3169224, 47.6081041 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278688, "project_id": 14, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3168848, 47.608137 ], [ -122.3166754, 47.6081337 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278689, "project_id": 14, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316621, 47.608108 ], [ -122.3166211, 47.6079827 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278690, "project_id": 14, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166645, 47.6079417 ], [ -122.3168767, 47.6079426 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278692, "project_id": 14, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166645, 47.6079417 ], [ -122.3166267, 47.6079643 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278693, "project_id": 14, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166211, 47.6079827 ], [ -122.3166267, 47.6079643 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278695, "project_id": 14, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169422, 47.6079842 ], [ -122.3169211, 47.6079673 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278696, "project_id": 14, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3168767, 47.6079426 ], [ -122.3169211, 47.6079673 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278697, "project_id": 14, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316922, 47.6081251 ], [ -122.3168848, 47.608137 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278699, "project_id": 14, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169224, 47.6081041 ], [ -122.316922, 47.6081251 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278701, "project_id": 14, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316621, 47.608108 ], [ -122.3166464, 47.6081243 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278702, "project_id": 14, "task_id": 303 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166754, 47.6081337 ], [ -122.3166464, 47.6081243 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278703, "project_id": 14, "task_id": 283 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3156147, 47.6079852 ], [ -122.3155908, 47.6081078 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278704, "project_id": 14, "task_id": 283 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155609, 47.6081348 ], [ -122.3153833, 47.6081365 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278706, "project_id": 14, "task_id": 283 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153835, 47.6079614 ], [ -122.3155644, 47.6079565 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278707, "project_id": 14, "task_id": 283 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153523, 47.6079682 ], [ -122.3153644, 47.6079554 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278708, "project_id": 14, "task_id": 283 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153835, 47.6079614 ], [ -122.3153644, 47.6079554 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278710, "project_id": 14, "task_id": 283 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.315582, 47.6079491 ], [ -122.3156285, 47.6079743 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278711, "project_id": 14, "task_id": 283 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3156147, 47.6079852 ], [ -122.3156285, 47.6079743 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278712, "project_id": 14, "task_id": 283 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155644, 47.6079565 ], [ -122.315582, 47.6079491 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278713, "project_id": 14, "task_id": 283 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155983, 47.6081245 ], [ -122.3155877, 47.6081375 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278714, "project_id": 14, "task_id": 283 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155609, 47.6081348 ], [ -122.3155877, 47.6081375 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278715, "project_id": 14, "task_id": 283 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155908, 47.6081078 ], [ -122.3155983, 47.6081245 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278716, "project_id": 14, "task_id": 283 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.315362, 47.6081299 ], [ -122.3153479, 47.6081198 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278718, "project_id": 14, "task_id": 283 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153833, 47.6081365 ], [ -122.315362, 47.6081299 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278719, "project_id": 14, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140937, 47.6079408 ], [ -122.314262, 47.6079408 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278720, "project_id": 14, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142826, 47.6079727 ], [ -122.3142834, 47.6081171 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278721, "project_id": 14, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142529, 47.6081171 ], [ -122.3140876, 47.6081164 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278722, "project_id": 14, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140361, 47.6080996 ], [ -122.3140375, 47.6079754 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278723, "project_id": 14, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140577, 47.6081174 ], [ -122.3140336, 47.6081129 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278724, "project_id": 14, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140361, 47.6080996 ], [ -122.3140336, 47.6081129 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278725, "project_id": 14, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140876, 47.6081164 ], [ -122.3140577, 47.6081174 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278726, "project_id": 14, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140386, 47.6079623 ], [ -122.3140398, 47.6079411 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278727, "project_id": 14, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140937, 47.6079408 ], [ -122.3140398, 47.6079411 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278728, "project_id": 14, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140375, 47.6079754 ], [ -122.3140386, 47.6079623 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278729, "project_id": 14, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142824, 47.6079408 ], [ -122.3142827, 47.607962 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278730, "project_id": 14, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142826, 47.6079727 ], [ -122.3142827, 47.607962 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278731, "project_id": 14, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314262, 47.6079408 ], [ -122.3142824, 47.6079408 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278732, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127484, 47.6079524 ], [ -122.3127649, 47.607953 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278733, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127982, 47.6079519 ], [ -122.3127649, 47.607953 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278734, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.312749, 47.6079738 ], [ -122.3127484, 47.6079524 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278735, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129662, 47.60795 ], [ -122.3129665, 47.6079606 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278736, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129667, 47.6079716 ], [ -122.3129665, 47.6079606 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278737, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129305, 47.6079507 ], [ -122.3129662, 47.60795 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278738, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.312759, 47.6081258 ], [ -122.3127589, 47.6081106 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278739, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.312759, 47.6080952 ], [ -122.3127589, 47.6081106 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278740, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.312797, 47.608124 ], [ -122.312759, 47.6081258 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278742, "project_id": 14, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116568, 47.6079668 ], [ -122.3116605, 47.6080818 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278743, "project_id": 14, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116186, 47.6081076 ], [ -122.3114787, 47.6081098 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278744, "project_id": 14, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114468, 47.6080818 ], [ -122.311436, 47.6079535 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278745, "project_id": 14, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114406, 47.6081314 ], [ -122.3114207, 47.6081037 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278746, "project_id": 14, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114468, 47.6080818 ], [ -122.3114207, 47.6081037 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278747, "project_id": 14, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114787, 47.6081098 ], [ -122.3114406, 47.6081314 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278748, "project_id": 14, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114001, 47.6079528 ], [ -122.3114428, 47.607929 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278750, "project_id": 14, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311436, 47.6079535 ], [ -122.3114001, 47.6079528 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278751, "project_id": 14, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116565, 47.6079392 ], [ -122.3116718, 47.6079515 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278752, "project_id": 14, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116568, 47.6079668 ], [ -122.3116718, 47.6079515 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278754, "project_id": 14, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116863, 47.6081049 ], [ -122.3116705, 47.6081262 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278755, "project_id": 14, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116186, 47.6081076 ], [ -122.3116705, 47.6081262 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278756, "project_id": 14, "task_id": 125 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116605, 47.6080818 ], [ -122.3116863, 47.6081049 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278757, "project_id": 14, "task_id": 136 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103209, 47.6079686 ], [ -122.3103383, 47.6080895 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278758, "project_id": 14, "task_id": 136 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103116, 47.6081128 ], [ -122.3101916, 47.6081188 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278759, "project_id": 14, "task_id": 136 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101564, 47.6080869 ], [ -122.3101522, 47.6079672 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278760, "project_id": 14, "task_id": 136 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101416, 47.6081282 ], [ -122.3101218, 47.6080991 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278761, "project_id": 14, "task_id": 136 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101564, 47.6080869 ], [ -122.3101218, 47.6080991 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278762, "project_id": 14, "task_id": 136 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101916, 47.6081188 ], [ -122.3101416, 47.6081282 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278763, "project_id": 14, "task_id": 136 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101508, 47.6079441 ], [ -122.3103419, 47.6079469 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278764, "project_id": 14, "task_id": 136 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103209, 47.6079686 ], [ -122.3103419, 47.6079469 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278765, "project_id": 14, "task_id": 136 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101522, 47.6079672 ], [ -122.3101508, 47.6079441 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278766, "project_id": 14, "task_id": 136 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103523, 47.6081034 ], [ -122.3103243, 47.6081293 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278767, "project_id": 14, "task_id": 136 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103116, 47.6081128 ], [ -122.3103243, 47.6081293 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278768, "project_id": 14, "task_id": 136 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103383, 47.6080895 ], [ -122.3103523, 47.6081034 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278779, "project_id": 14, "task_id": 6 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090521, 47.6079055 ], [ -122.3090881, 47.6079397 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278780, "project_id": 14, "task_id": 6 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.309089, 47.607954 ], [ -122.3090881, 47.6079397 ] ] } }, +{ "type": "Feature", "properties": { "id": 1278781, "project_id": 14, "task_id": 6 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.30904, 47.6079201 ], [ -122.3090521, 47.6079055 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288100, "project_id": 14, "task_id": 255 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182301, 47.6034818 ], [ -122.3182285, 47.6035586 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288101, "project_id": 14, "task_id": 329 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.318184, 47.6035835 ], [ -122.3180499, 47.6035829 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288102, "project_id": 14, "task_id": 329 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180206, 47.6035626 ], [ -122.318021, 47.6034745 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288103, "project_id": 14, "task_id": 255 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.318045, 47.6034569 ], [ -122.3181918, 47.6034576 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288104, "project_id": 14, "task_id": 329 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.318016, 47.6034622 ], [ -122.3180237, 47.6034576 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288105, "project_id": 14, "task_id": 329 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.318045, 47.6034569 ], [ -122.3180237, 47.6034576 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288106, "project_id": 14, "task_id": 329 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.318021, 47.6034745 ], [ -122.318016, 47.6034622 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288107, "project_id": 14, "task_id": 255 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182265, 47.6034556 ], [ -122.3182332, 47.6034579 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288108, "project_id": 14, "task_id": 255 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182301, 47.6034818 ], [ -122.3182332, 47.6034579 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288109, "project_id": 14, "task_id": 255 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3181918, 47.6034576 ], [ -122.3182265, 47.6034556 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288110, "project_id": 14, "task_id": 329 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180231, 47.603587 ], [ -122.3180128, 47.6035804 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288111, "project_id": 14, "task_id": 329 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180206, 47.6035626 ], [ -122.3180128, 47.6035804 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288112, "project_id": 14, "task_id": 329 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180499, 47.6035829 ], [ -122.3180231, 47.603587 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288113, "project_id": 14, "task_id": 425 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31823, 47.6043207 ], [ -122.3182249, 47.6044002 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288114, "project_id": 14, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3181805, 47.6044377 ], [ -122.3180558, 47.6044382 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288115, "project_id": 14, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.318008, 47.6043998 ], [ -122.31802, 47.6043204 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288116, "project_id": 14, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180534, 47.60429 ], [ -122.3181861, 47.604288 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288117, "project_id": 14, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.318018, 47.6042854 ], [ -122.3180172, 47.6042786 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288118, "project_id": 14, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180534, 47.60429 ], [ -122.3180172, 47.6042786 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288119, "project_id": 14, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31802, 47.6043204 ], [ -122.318018, 47.6042854 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288120, "project_id": 14, "task_id": 425 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182261, 47.604278 ], [ -122.3182367, 47.6042857 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288121, "project_id": 14, "task_id": 425 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31823, 47.6043207 ], [ -122.3182367, 47.6042857 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288122, "project_id": 14, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3181861, 47.604288 ], [ -122.3182261, 47.604278 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288123, "project_id": 14, "task_id": 425 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182434, 47.604438 ], [ -122.3182335, 47.6044438 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288124, "project_id": 14, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3181805, 47.6044377 ], [ -122.3182335, 47.6044438 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288125, "project_id": 14, "task_id": 425 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182249, 47.6044002 ], [ -122.3182434, 47.604438 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288126, "project_id": 14, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180086, 47.6044377 ], [ -122.3180074, 47.6044336 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288127, "project_id": 14, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.318008, 47.6043998 ], [ -122.3180074, 47.6044336 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288128, "project_id": 14, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180558, 47.6044382 ], [ -122.3180086, 47.6044377 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288129, "project_id": 14, "task_id": 388 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182338, 47.6051615 ], [ -122.3182321, 47.6052382 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288130, "project_id": 14, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.318191, 47.6052727 ], [ -122.3180566, 47.605271 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288131, "project_id": 14, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180142, 47.6052402 ], [ -122.3180197, 47.6051594 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288132, "project_id": 14, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180402, 47.6051349 ], [ -122.318189, 47.605135 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288133, "project_id": 14, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180013, 47.6051332 ], [ -122.3180166, 47.6051343 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288134, "project_id": 14, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180402, 47.6051349 ], [ -122.3180166, 47.6051343 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288135, "project_id": 14, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180197, 47.6051594 ], [ -122.3180013, 47.6051332 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288136, "project_id": 14, "task_id": 388 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.318225, 47.6051298 ], [ -122.3182388, 47.6051376 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288137, "project_id": 14, "task_id": 388 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182338, 47.6051615 ], [ -122.3182388, 47.6051376 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288138, "project_id": 14, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.318189, 47.605135 ], [ -122.318225, 47.6051298 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288139, "project_id": 14, "task_id": 388 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182351, 47.6052617 ], [ -122.318235, 47.6052743 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288140, "project_id": 14, "task_id": 388 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.318191, 47.6052727 ], [ -122.318235, 47.6052743 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288141, "project_id": 14, "task_id": 388 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182321, 47.6052382 ], [ -122.3182351, 47.6052617 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288142, "project_id": 14, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180111, 47.6052882 ], [ -122.3179951, 47.6052723 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288143, "project_id": 14, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180142, 47.6052402 ], [ -122.3179951, 47.6052723 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288144, "project_id": 14, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180566, 47.605271 ], [ -122.3180111, 47.6052882 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288145, "project_id": 14, "task_id": 325 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.318213, 47.6061487 ], [ -122.318204, 47.6062706 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288146, "project_id": 14, "task_id": 325 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180274, 47.6062785 ], [ -122.3180201, 47.6061548 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288147, "project_id": 14, "task_id": 325 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180498, 47.6061362 ], [ -122.3181904, 47.6061313 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288148, "project_id": 14, "task_id": 325 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180204, 47.606149 ], [ -122.3180213, 47.6061367 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288149, "project_id": 14, "task_id": 325 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180498, 47.6061362 ], [ -122.3180213, 47.6061367 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288150, "project_id": 14, "task_id": 325 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180201, 47.6061548 ], [ -122.3180204, 47.606149 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288151, "project_id": 14, "task_id": 325 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182349, 47.6061272 ], [ -122.3182367, 47.606136 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288152, "project_id": 14, "task_id": 325 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.318213, 47.6061487 ], [ -122.3182367, 47.606136 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288153, "project_id": 14, "task_id": 325 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3181904, 47.6061313 ], [ -122.3182349, 47.6061272 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288154, "project_id": 14, "task_id": 325 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182052, 47.6062892 ], [ -122.3180241, 47.6062931 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288155, "project_id": 14, "task_id": 325 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180274, 47.6062785 ], [ -122.3180241, 47.6062931 ] ] } }, +{ "type": "Feature", "properties": { "id": 1288156, "project_id": 14, "task_id": 325 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.318204, 47.6062706 ], [ -122.3182052, 47.6062892 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291257, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223003, 47.6027316 ], [ -122.322119, 47.6027696 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291258, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322047, 47.6027446 ], [ -122.3220387, 47.6026657 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291259, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322217, 47.6026298 ], [ -122.3223003, 47.6027316 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291260, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220418, 47.6026401 ], [ -122.3220884, 47.6026545 ], [ -122.3222066, 47.6026125 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291261, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322217, 47.6026298 ], [ -122.3222066, 47.6026125 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291262, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220387, 47.6026657 ], [ -122.3220418, 47.6026401 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291263, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223228, 47.602739 ], [ -122.3223608, 47.6027793 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291265, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223003, 47.6027316 ], [ -122.3223228, 47.602739 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291266, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220887, 47.6027814 ], [ -122.3220435, 47.6027762 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291267, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322047, 47.6027446 ], [ -122.3220435, 47.6027762 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291268, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322119, 47.6027696 ], [ -122.3220887, 47.6027814 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291269, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240296, 47.6049575 ], [ -122.3239658, 47.6048428 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291270, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3247764, 47.6054414 ], [ -122.3249109, 47.6055935 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291271, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249109, 47.6055935 ], [ -122.324768, 47.605676 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291272, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324684, 47.6056641 ], [ -122.3245597, 47.6055717 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291273, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3245937, 47.6055134 ], [ -122.3247764, 47.6054414 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291274, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.32454, 47.6055552 ], [ -122.3245623, 47.6055161 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291275, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3245937, 47.6055134 ], [ -122.3245623, 47.6055161 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291276, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3245597, 47.6055717 ], [ -122.32454, 47.6055552 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291277, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3247811, 47.6054292 ], [ -122.3248131, 47.6054418 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291278, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3247764, 47.6054414 ], [ -122.3248131, 47.6054418 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291279, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3247764, 47.6054414 ], [ -122.3247811, 47.6054292 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291280, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249384, 47.6055828 ], [ -122.3249433, 47.6056074 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291281, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249109, 47.6055935 ], [ -122.3249433, 47.6056074 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291282, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249109, 47.6055935 ], [ -122.3249384, 47.6055828 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291283, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3247469, 47.6056844 ], [ -122.3246955, 47.6056758 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291284, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324684, 47.6056641 ], [ -122.3246955, 47.6056758 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291285, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324768, 47.605676 ], [ -122.3247469, 47.6056844 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291286, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3254742, 47.6061863 ], [ -122.3255547, 47.6062758 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291287, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3255359, 47.6063239 ], [ -122.3254131, 47.6063819 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291288, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3253617, 47.6063647 ], [ -122.3252742, 47.6062714 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291289, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252782, 47.6062372 ], [ -122.325425, 47.6061796 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291290, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252782, 47.6062372 ], [ -122.3252449, 47.6062335 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291291, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252742, 47.6062714 ], [ -122.3252312, 47.6062623 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291292, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325434, 47.6061665 ], [ -122.3254608, 47.6061682 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291293, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3254742, 47.6061863 ], [ -122.3254608, 47.6061682 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291294, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325425, 47.6061796 ], [ -122.325434, 47.6061665 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291295, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325591, 47.6062987 ], [ -122.3255831, 47.6063223 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291296, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3255359, 47.6063239 ], [ -122.3255831, 47.6063223 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291297, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3255547, 47.6062758 ], [ -122.325591, 47.6062987 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291298, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3253958, 47.6063898 ], [ -122.3253608, 47.6063774 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291299, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3253617, 47.6063647 ], [ -122.3253608, 47.6063774 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291300, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3254131, 47.6063819 ], [ -122.3253958, 47.6063898 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291302, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262035, 47.6070157 ], [ -122.3260546, 47.6070907 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291303, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260173, 47.6070788 ], [ -122.3259282, 47.6069875 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291304, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3259454, 47.606955 ], [ -122.3260732, 47.6069016 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291305, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3259077, 47.6069661 ], [ -122.3259284, 47.6069606 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291306, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3259454, 47.606955 ], [ -122.3259284, 47.6069606 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291307, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3259282, 47.6069875 ], [ -122.3259077, 47.6069661 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291308, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.32611, 47.6068863 ], [ -122.3261332, 47.6068812 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291310, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260732, 47.6069016 ], [ -122.32611, 47.6068863 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291314, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260389, 47.607102 ], [ -122.3260305, 47.6070947 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291315, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260173, 47.6070788 ], [ -122.3260305, 47.6070947 ] ] } }, +{ "type": "Feature", "properties": { "id": 1291316, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260546, 47.6070907 ], [ -122.3260389, 47.607102 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292721, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322316, 47.6017533 ], [ -122.322316, 47.6016028 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292722, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208296, 47.6018099 ], [ -122.3206799, 47.6018531 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292723, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3204438, 47.6017338 ], [ -122.320444, 47.6016445 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292724, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209384, 47.6016525 ], [ -122.3209396, 47.6017366 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292725, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3204468, 47.6015883 ], [ -122.3208451, 47.6015806 ], [ -122.3209332, 47.6015789 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292726, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209384, 47.6016525 ], [ -122.3209332, 47.6015789 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292727, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320444, 47.6016445 ], [ -122.3204468, 47.6015883 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292728, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209455, 47.6017954 ], [ -122.320892, 47.6018026 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292729, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208296, 47.6018099 ], [ -122.320892, 47.6018026 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292730, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209396, 47.6017366 ], [ -122.3209455, 47.6017954 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292731, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206075, 47.601874 ], [ -122.3205793, 47.6018289 ], [ -122.3204515, 47.6017865 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292732, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3204438, 47.6017338 ], [ -122.3204515, 47.6017865 ] ] } }, +{ "type": "Feature", "properties": { "id": 1292733, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206799, 47.6018531 ], [ -122.3206075, 47.601874 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295860, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320848, 47.6026416 ], [ -122.3208609, 47.60276 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295861, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208609, 47.60276 ], [ -122.320647, 47.6027558 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295862, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3205969, 47.6027326 ], [ -122.320588, 47.6026639 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295863, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320646, 47.6026358 ], [ -122.320848, 47.6026416 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295864, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3205895, 47.6026468 ], [ -122.3206148, 47.6026354 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295865, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320646, 47.6026358 ], [ -122.3206148, 47.6026354 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295866, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320588, 47.6026639 ], [ -122.3205895, 47.6026468 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295868, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320848, 47.6026416 ], [ -122.3209014, 47.6026216 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295869, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320848, 47.6026416 ], [ -122.3209014, 47.6026216 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295871, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208609, 47.60276 ], [ -122.3209031, 47.6027754 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295872, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208609, 47.60276 ], [ -122.3209031, 47.6027754 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295874, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3205969, 47.6027326 ], [ -122.3206192, 47.6027585 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295875, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320647, 47.6027558 ], [ -122.3206192, 47.6027585 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295878, "project_id": 13, "task_id": 265 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209076, 47.6041476 ], [ -122.320911, 47.6042792 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295879, "project_id": 13, "task_id": 265 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209043, 47.6041086 ], [ -122.3209056, 47.6041209 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295880, "project_id": 13, "task_id": 265 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209076, 47.6041476 ], [ -122.3209056, 47.6041209 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295884, "project_id": 13, "task_id": 265 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320911, 47.6042792 ], [ -122.3209164, 47.6043047 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295888, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320938, 47.6046039 ], [ -122.3208949, 47.6048453 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295889, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208949, 47.6048453 ], [ -122.32065, 47.6046003 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295890, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206263, 47.6045287 ], [ -122.3206425, 47.6042773 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295891, "project_id": 13, "task_id": 265 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206425, 47.6042773 ], [ -122.3208729, 47.6044789 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295892, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206238, 47.6042632 ], [ -122.3206355, 47.6042584 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295893, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206425, 47.6042773 ], [ -122.3206355, 47.6042584 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295894, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206425, 47.6042773 ], [ -122.3206238, 47.6042632 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295895, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208994, 47.6045054 ], [ -122.3209545, 47.604591 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295896, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320938, 47.6046039 ], [ -122.3209545, 47.604591 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295897, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208729, 47.6044789 ], [ -122.3208994, 47.6045054 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295898, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206106, 47.6045864 ], [ -122.3206094, 47.6045393 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295899, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206263, 47.6045287 ], [ -122.3206094, 47.6045393 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295900, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.32065, 47.6046003 ], [ -122.3206106, 47.6045864 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295901, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208476, 47.6052899 ], [ -122.3206602, 47.6052868 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295902, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206034, 47.6052483 ], [ -122.320604, 47.6051686 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295904, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206158, 47.6051502 ], [ -122.3206167, 47.6051056 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295906, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320604, 47.6051686 ], [ -122.3206158, 47.6051502 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295907, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208988, 47.60514 ], [ -122.3208947, 47.6052888 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295908, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208476, 47.6052899 ], [ -122.3208947, 47.6052888 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295910, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206164, 47.6052905 ], [ -122.3206162, 47.6052754 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295911, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206034, 47.6052483 ], [ -122.3206162, 47.6052754 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295912, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206602, 47.6052868 ], [ -122.3206164, 47.6052905 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295913, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320654, 47.6061365 ], [ -122.3208581, 47.606092 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295914, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209084, 47.6061094 ], [ -122.3209425, 47.6062302 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295915, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208687, 47.6062813 ], [ -122.3206538, 47.6063085 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295916, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320599, 47.6062589 ], [ -122.3206064, 47.606155 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295917, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206343, 47.6062938 ], [ -122.3205982, 47.6062892 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295918, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320599, 47.6062589 ], [ -122.3205982, 47.6062892 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295919, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206538, 47.6063085 ], [ -122.3206343, 47.6062938 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295920, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206016, 47.6061365 ], [ -122.320627, 47.6061245 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295921, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320654, 47.6061365 ], [ -122.320627, 47.6061245 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295922, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206064, 47.606155 ], [ -122.3206016, 47.6061365 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295923, "project_id": 13, "task_id": 50 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208824, 47.6060777 ], [ -122.3209189, 47.6060925 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295924, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209084, 47.6061094 ], [ -122.3209189, 47.6060925 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295925, "project_id": 13, "task_id": 50 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208581, 47.606092 ], [ -122.3208824, 47.6060777 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295926, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209632, 47.6062513 ], [ -122.320908, 47.6062818 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295927, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208687, 47.6062813 ], [ -122.320908, 47.6062818 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295928, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209425, 47.6062302 ], [ -122.3209632, 47.6062513 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295929, "project_id": 14, "task_id": 174 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208785, 47.6072894 ], [ -122.320593, 47.6074222 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295930, "project_id": 13, "task_id": 163 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209239, 47.607089 ], [ -122.320927, 47.6072364 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295932, "project_id": 14, "task_id": 176 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3207057, 47.610041 ], [ -122.3208914, 47.6100382 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295940, "project_id": 14, "task_id": 176 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3207036, 47.6102776 ], [ -122.3206867, 47.6100405 ] ] } }, +{ "type": "Feature", "properties": { "id": 1295941, "project_id": 14, "task_id": 176 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3207057, 47.610041 ], [ -122.3206867, 47.6100405 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305904, "project_id": 14, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3117006, 47.6016446 ], [ -122.3116985, 47.6017368 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305905, "project_id": 14, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31165, 47.6017629 ], [ -122.311523, 47.6017605 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305906, "project_id": 14, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114596, 47.6017346 ], [ -122.311456, 47.601624 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305907, "project_id": 14, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114857, 47.6016107 ], [ -122.3116512, 47.6016209 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305908, "project_id": 14, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114423, 47.6016153 ], [ -122.311475, 47.6016021 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305909, "project_id": 14, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114857, 47.6016107 ], [ -122.311475, 47.6016021 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305910, "project_id": 14, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311456, 47.601624 ], [ -122.3114423, 47.6016153 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305911, "project_id": 14, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116893, 47.6016188 ], [ -122.3117006, 47.6016376 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305912, "project_id": 14, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3117006, 47.6016446 ], [ -122.3117006, 47.6016376 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305913, "project_id": 14, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116512, 47.6016209 ], [ -122.3116893, 47.6016188 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305914, "project_id": 14, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311705, 47.6017715 ], [ -122.3116957, 47.6017842 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305915, "project_id": 14, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31165, 47.6017629 ], [ -122.3116957, 47.6017842 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305916, "project_id": 14, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116985, 47.6017368 ], [ -122.311705, 47.6017715 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305917, "project_id": 14, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114757, 47.6017706 ], [ -122.3114575, 47.6017656 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305918, "project_id": 14, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114596, 47.6017346 ], [ -122.3114575, 47.6017656 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305919, "project_id": 14, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311523, 47.6017605 ], [ -122.3114757, 47.6017706 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305920, "project_id": 14, "task_id": 367 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3117014, 47.6026485 ], [ -122.3116918, 47.6027259 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305922, "project_id": 14, "task_id": 367 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114711, 47.6026279 ], [ -122.3116534, 47.6026334 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305924, "project_id": 14, "task_id": 367 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114711, 47.6026279 ], [ -122.3114661, 47.6026237 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305927, "project_id": 14, "task_id": 367 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3117014, 47.6026485 ], [ -122.3117018, 47.6026259 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305928, "project_id": 14, "task_id": 367 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116534, 47.6026334 ], [ -122.3117018, 47.6026259 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305929, "project_id": 14, "task_id": 291 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116907, 47.602744 ], [ -122.3113927, 47.6027441 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305931, "project_id": 14, "task_id": 367 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116918, 47.6027259 ], [ -122.3116907, 47.602744 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305934, "project_id": 14, "task_id": 287 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116846, 47.604303 ], [ -122.3116824, 47.6043811 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305935, "project_id": 14, "task_id": 287 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114759, 47.6042799 ], [ -122.3116104, 47.6042788 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305936, "project_id": 14, "task_id": 287 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116846, 47.604303 ], [ -122.311684, 47.6042782 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305937, "project_id": 14, "task_id": 287 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114793, 47.6044066 ], [ -122.3114768, 47.6043116 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305938, "project_id": 14, "task_id": 287 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116826, 47.6044034 ], [ -122.3116832, 47.6044121 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305939, "project_id": 14, "task_id": 287 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311633, 47.604411 ], [ -122.3116832, 47.6044121 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305940, "project_id": 14, "task_id": 287 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116824, 47.6043811 ], [ -122.3116826, 47.6044034 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305941, "project_id": 14, "task_id": 287 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114818, 47.6044494 ], [ -122.3114793, 47.6044066 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305944, "project_id": 14, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311467, 47.6062507 ], [ -122.311468, 47.6061215 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305945, "project_id": 14, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311513, 47.6060914 ], [ -122.3116246, 47.6060955 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305946, "project_id": 14, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31167, 47.6061232 ], [ -122.311667, 47.6062468 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305947, "project_id": 14, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116374, 47.6062889 ], [ -122.3115123, 47.6062909 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305949, "project_id": 14, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311467, 47.6062507 ], [ -122.3114665, 47.6062891 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305950, "project_id": 14, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3115123, 47.6062909 ], [ -122.3114665, 47.6062891 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305952, "project_id": 14, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311513, 47.6060914 ], [ -122.3114665, 47.6060917 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305953, "project_id": 14, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311468, 47.6061215 ], [ -122.3114665, 47.6060917 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305955, "project_id": 14, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31167, 47.6061232 ], [ -122.31167, 47.6060957 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305956, "project_id": 14, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116246, 47.6060955 ], [ -122.31167, 47.6060957 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305958, "project_id": 14, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116374, 47.6062889 ], [ -122.3116683, 47.6062856 ] ] } }, +{ "type": "Feature", "properties": { "id": 1305959, "project_id": 14, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311667, 47.6062468 ], [ -122.3116683, 47.6062856 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311376, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252194, 47.5999691 ], [ -122.325252, 47.6001016 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311377, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249364, 47.6000964 ], [ -122.3249507, 47.5999722 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311378, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249908, 47.5999602 ], [ -122.3251533, 47.5999594 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311379, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.32495, 47.599958 ], [ -122.3249677, 47.5999579 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311380, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249908, 47.5999602 ], [ -122.3249677, 47.5999579 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311381, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249507, 47.5999722 ], [ -122.32495, 47.599958 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311382, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252509, 47.6001146 ], [ -122.3249357, 47.6001153 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311383, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249364, 47.6000964 ], [ -122.3249357, 47.6001153 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311384, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325252, 47.6001016 ], [ -122.3252509, 47.6001146 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311385, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3250028, 47.5990605 ], [ -122.3251417, 47.5990629 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311386, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325229, 47.5991306 ], [ -122.3252163, 47.599262 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311387, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251388, 47.5993406 ], [ -122.3250007, 47.5993315 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311388, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249148, 47.5992637 ], [ -122.3249203, 47.5991292 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311389, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249557, 47.599327 ], [ -122.3249271, 47.5993067 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311390, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249148, 47.5992637 ], [ -122.3249271, 47.5993067 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311391, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3250007, 47.5993315 ], [ -122.3249557, 47.599327 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311392, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249278, 47.5990851 ], [ -122.3249554, 47.5990614 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311393, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3250028, 47.5990605 ], [ -122.3249554, 47.5990614 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311394, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249203, 47.5991292 ], [ -122.3249278, 47.5990851 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311395, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251388, 47.5993406 ], [ -122.3251816, 47.5993376 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311396, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252163, 47.599262 ], [ -122.3252107, 47.5993013 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311398, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251505, 47.5984408 ], [ -122.3249909, 47.5984438 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311399, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249523, 47.5984267 ], [ -122.3249535, 47.5983099 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311403, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249535, 47.5983099 ], [ -122.3249561, 47.598288 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311404, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249751, 47.5984516 ], [ -122.3249529, 47.5984379 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311405, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249523, 47.5984267 ], [ -122.3249529, 47.5984379 ] ] } }, +{ "type": "Feature", "properties": { "id": 1311406, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249909, 47.5984438 ], [ -122.3249751, 47.5984516 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322893, "project_id": 13, "task_id": 195 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223456, 47.5992815 ], [ -122.3223357, 47.5991259 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322894, "project_id": 13, "task_id": 186 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223834, 47.5990618 ], [ -122.322526, 47.5990545 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322896, "project_id": 13, "task_id": 186 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223834, 47.5990618 ], [ -122.3223385, 47.599067 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322897, "project_id": 13, "task_id": 186 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223357, 47.5991259 ], [ -122.3223385, 47.599067 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322898, "project_id": 13, "task_id": 186 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225686, 47.5990962 ], [ -122.3225708, 47.5992771 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322899, "project_id": 13, "task_id": 195 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223456, 47.5992815 ], [ -122.3223465, 47.5992941 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322900, "project_id": 13, "task_id": 186 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322526, 47.5990545 ], [ -122.3225766, 47.5990718 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322901, "project_id": 13, "task_id": 7 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197756, 47.5991003 ], [ -122.319772, 47.5992767 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322902, "project_id": 14, "task_id": 406 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319494, 47.5992729 ], [ -122.319494, 47.599101 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322903, "project_id": 14, "task_id": 406 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319556, 47.5990693 ], [ -122.319709, 47.5990694 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322904, "project_id": 14, "task_id": 406 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194942, 47.59907 ], [ -122.3195314, 47.5990694 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322905, "project_id": 14, "task_id": 406 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319556, 47.5990693 ], [ -122.3195314, 47.5990694 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322906, "project_id": 14, "task_id": 406 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319494, 47.599101 ], [ -122.3194942, 47.59907 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322907, "project_id": 14, "task_id": 406 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197568, 47.5990697 ], [ -122.3197755, 47.5990786 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322908, "project_id": 13, "task_id": 7 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197756, 47.5991003 ], [ -122.3197755, 47.5990786 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322909, "project_id": 14, "task_id": 406 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319709, 47.5990694 ], [ -122.3197568, 47.5990697 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322910, "project_id": 13, "task_id": 7 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319735, 47.5992926 ], [ -122.3195628, 47.5992976 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322911, "project_id": 14, "task_id": 406 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319494, 47.5992729 ], [ -122.3194944, 47.5992865 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322912, "project_id": 13, "task_id": 7 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197806, 47.5992984 ], [ -122.319735, 47.5992926 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322913, "project_id": 14, "task_id": 152 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317137, 47.5990911 ], [ -122.317344, 47.5990909 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322914, "project_id": 14, "task_id": 152 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317393, 47.5991126 ], [ -122.317381, 47.5992856 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322915, "project_id": 14, "task_id": 152 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317322, 47.5993161 ], [ -122.317096, 47.599313 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322916, "project_id": 14, "task_id": 152 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3170665, 47.5992898 ], [ -122.317091, 47.5991268 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322918, "project_id": 14, "task_id": 152 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3170665, 47.5992898 ], [ -122.3170639, 47.5993132 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322919, "project_id": 14, "task_id": 152 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317096, 47.599313 ], [ -122.3170639, 47.5993132 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322920, "project_id": 14, "task_id": 152 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3170947, 47.5991005 ], [ -122.3171217, 47.5990913 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322921, "project_id": 14, "task_id": 152 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317137, 47.5990911 ], [ -122.3171217, 47.5990913 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322922, "project_id": 14, "task_id": 152 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317091, 47.5991268 ], [ -122.3170947, 47.5991005 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322923, "project_id": 14, "task_id": 152 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173609, 47.5990837 ], [ -122.3173951, 47.5990837 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322924, "project_id": 14, "task_id": 153 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317393, 47.5991126 ], [ -122.3173951, 47.5990837 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322925, "project_id": 14, "task_id": 152 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317344, 47.5990909 ], [ -122.3173609, 47.5990837 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322926, "project_id": 14, "task_id": 152 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173788, 47.599321 ], [ -122.3173493, 47.5993215 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322927, "project_id": 14, "task_id": 152 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317322, 47.5993161 ], [ -122.3173493, 47.5993215 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322928, "project_id": 14, "task_id": 152 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317381, 47.5992856 ], [ -122.3173788, 47.599321 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322929, "project_id": 14, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3145019, 47.5993195 ], [ -122.314304, 47.5994102 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322930, "project_id": 14, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142582, 47.5994042 ], [ -122.31405, 47.5993442 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322931, "project_id": 14, "task_id": 190 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3117083, 47.5991686 ], [ -122.3117043, 47.5993068 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322932, "project_id": 14, "task_id": 190 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116713, 47.5993216 ], [ -122.311519, 47.5993232 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322933, "project_id": 14, "task_id": 190 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311478, 47.5993052 ], [ -122.311471, 47.599159 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322934, "project_id": 14, "task_id": 190 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311508, 47.5991424 ], [ -122.311674, 47.5991443 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322935, "project_id": 14, "task_id": 190 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114592, 47.5991476 ], [ -122.3114844, 47.5991415 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322936, "project_id": 14, "task_id": 190 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311508, 47.5991424 ], [ -122.3114844, 47.5991415 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322937, "project_id": 14, "task_id": 190 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311471, 47.599159 ], [ -122.3114592, 47.5991476 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322939, "project_id": 14, "task_id": 190 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3117083, 47.5991686 ], [ -122.3117026, 47.5991466 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322940, "project_id": 14, "task_id": 190 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311674, 47.5991443 ], [ -122.3117026, 47.5991466 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322941, "project_id": 14, "task_id": 190 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3117149, 47.5993087 ], [ -122.311708, 47.599325 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322942, "project_id": 14, "task_id": 190 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116713, 47.5993216 ], [ -122.311708, 47.599325 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322943, "project_id": 14, "task_id": 190 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3117043, 47.5993068 ], [ -122.3117149, 47.5993087 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322944, "project_id": 14, "task_id": 190 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114847, 47.599323 ], [ -122.311474, 47.5993121 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322945, "project_id": 14, "task_id": 190 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311478, 47.5993052 ], [ -122.311474, 47.5993121 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322946, "project_id": 14, "task_id": 190 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311519, 47.5993232 ], [ -122.3114847, 47.599323 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322947, "project_id": 14, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310384, 47.5991659 ], [ -122.3103934, 47.5993094 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322948, "project_id": 14, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103545, 47.599332 ], [ -122.3102308, 47.5993312 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322949, "project_id": 14, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101778, 47.5992976 ], [ -122.3101772, 47.5991669 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322950, "project_id": 14, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310174, 47.5993243 ], [ -122.3101641, 47.5993239 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322951, "project_id": 14, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101778, 47.5992976 ], [ -122.3101641, 47.5993239 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322952, "project_id": 14, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3102308, 47.5993312 ], [ -122.310174, 47.5993243 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322953, "project_id": 14, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101774, 47.5991609 ], [ -122.3103863, 47.5991564 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322954, "project_id": 14, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310384, 47.5991659 ], [ -122.3103863, 47.5991564 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322955, "project_id": 14, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101772, 47.5991669 ], [ -122.3101774, 47.5991609 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322956, "project_id": 14, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3104007, 47.5993155 ], [ -122.3104021, 47.5993327 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322957, "project_id": 14, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103545, 47.599332 ], [ -122.3104021, 47.5993327 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322958, "project_id": 14, "task_id": 203 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103934, 47.5993094 ], [ -122.3104007, 47.5993155 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322959, "project_id": 14, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.30909, 47.5991677 ], [ -122.309099, 47.5993194 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322960, "project_id": 14, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.309055, 47.5993453 ], [ -122.308915, 47.5993347 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322961, "project_id": 14, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088641, 47.5993039 ], [ -122.3088776, 47.5991722 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322962, "project_id": 14, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3089123, 47.5991445 ], [ -122.3090691, 47.5991512 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322963, "project_id": 14, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088525, 47.5991542 ], [ -122.3088667, 47.599139 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322964, "project_id": 14, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3089123, 47.5991445 ], [ -122.3088667, 47.599139 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322965, "project_id": 14, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088776, 47.5991722 ], [ -122.3088525, 47.5991542 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322966, "project_id": 14, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3091036, 47.599146 ], [ -122.3091003, 47.5991643 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322967, "project_id": 14, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.30909, 47.5991677 ], [ -122.3091003, 47.5991643 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322968, "project_id": 14, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090691, 47.5991512 ], [ -122.3091036, 47.599146 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322969, "project_id": 14, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3091045, 47.5993284 ], [ -122.3090861, 47.5993327 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322970, "project_id": 14, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.309055, 47.5993453 ], [ -122.3090861, 47.5993327 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322971, "project_id": 14, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.309099, 47.5993194 ], [ -122.3091045, 47.5993284 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322972, "project_id": 14, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.308883, 47.5993218 ], [ -122.308855, 47.5993214 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322973, "project_id": 14, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088641, 47.5993039 ], [ -122.308855, 47.5993214 ] ] } }, +{ "type": "Feature", "properties": { "id": 1322974, "project_id": 14, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.308915, 47.5993347 ], [ -122.308883, 47.5993218 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353566, "project_id": 14, "task_id": 293 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3130063, 47.6016381 ], [ -122.3130066, 47.601751 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353567, "project_id": 14, "task_id": 293 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129471, 47.6017781 ], [ -122.3128312, 47.6017765 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353568, "project_id": 14, "task_id": 293 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127671, 47.6017376 ], [ -122.3127773, 47.6016453 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353569, "project_id": 14, "task_id": 293 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3128352, 47.6016085 ], [ -122.3129561, 47.6016115 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353570, "project_id": 14, "task_id": 293 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127733, 47.6016383 ], [ -122.312786, 47.6016087 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353571, "project_id": 14, "task_id": 293 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3128352, 47.6016085 ], [ -122.312786, 47.6016087 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353572, "project_id": 14, "task_id": 293 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127773, 47.6016453 ], [ -122.3127733, 47.6016383 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353573, "project_id": 14, "task_id": 293 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.312999, 47.6016059 ], [ -122.313009, 47.601615 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353574, "project_id": 14, "task_id": 293 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3130063, 47.6016381 ], [ -122.313009, 47.601615 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353575, "project_id": 14, "task_id": 293 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129561, 47.6016115 ], [ -122.312999, 47.6016059 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353576, "project_id": 14, "task_id": 293 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.313004, 47.6017678 ], [ -122.3129903, 47.6017793 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353577, "project_id": 14, "task_id": 293 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129471, 47.6017781 ], [ -122.3129903, 47.6017793 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353578, "project_id": 14, "task_id": 293 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3130066, 47.601751 ], [ -122.313004, 47.6017678 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353579, "project_id": 14, "task_id": 293 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127783, 47.6017748 ], [ -122.3127661, 47.6017662 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353580, "project_id": 14, "task_id": 293 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127671, 47.6017376 ], [ -122.3127661, 47.6017662 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353581, "project_id": 14, "task_id": 293 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3128312, 47.6017765 ], [ -122.3127783, 47.6017748 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353582, "project_id": 14, "task_id": 209 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.312984, 47.6061315 ], [ -122.3129823, 47.6062532 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353583, "project_id": 14, "task_id": 209 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.312929, 47.6062849 ], [ -122.312819, 47.6062847 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353584, "project_id": 14, "task_id": 209 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127711, 47.6062527 ], [ -122.3127666, 47.606134 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353585, "project_id": 14, "task_id": 209 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.312818, 47.6060962 ], [ -122.312932, 47.6060959 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353587, "project_id": 14, "task_id": 209 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.312818, 47.6060962 ], [ -122.3127675, 47.6060976 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353588, "project_id": 14, "task_id": 209 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127666, 47.606134 ], [ -122.3127675, 47.6060976 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353589, "project_id": 14, "task_id": 209 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129591, 47.6060966 ], [ -122.3129824, 47.6060971 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353590, "project_id": 14, "task_id": 209 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.312984, 47.6061315 ], [ -122.3129824, 47.6060971 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353591, "project_id": 14, "task_id": 209 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.312932, 47.6060959 ], [ -122.3129591, 47.6060966 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353592, "project_id": 14, "task_id": 209 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129823, 47.606284 ], [ -122.3129443, 47.6062844 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353593, "project_id": 14, "task_id": 209 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.312929, 47.6062849 ], [ -122.3129443, 47.6062844 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353594, "project_id": 14, "task_id": 209 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129823, 47.6062532 ], [ -122.3129823, 47.606284 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353596, "project_id": 14, "task_id": 209 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127711, 47.6062527 ], [ -122.3127711, 47.6062868 ] ] } }, +{ "type": "Feature", "properties": { "id": 1353597, "project_id": 14, "task_id": 209 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.312819, 47.6062847 ], [ -122.3127711, 47.6062868 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366366, "project_id": 14, "task_id": 101 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3139483, 47.5967486 ], [ -122.3139433, 47.5965952 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366367, "project_id": 14, "task_id": 101 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3139934, 47.5965632 ], [ -122.3141277, 47.5965638 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366369, "project_id": 14, "task_id": 101 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3139483, 47.5967486 ], [ -122.3139484, 47.5967661 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366672, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3230621, 47.6052303 ], [ -122.323147, 47.6053231 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366673, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323132, 47.6053624 ], [ -122.323009, 47.6053994 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366674, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322945, 47.6053931 ], [ -122.3228703, 47.6053088 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366675, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3228887, 47.6052643 ], [ -122.3229987, 47.6052246 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366676, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3230281, 47.6051941 ], [ -122.3230356, 47.6051942 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366677, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3230621, 47.6052303 ], [ -122.3230356, 47.6051942 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366678, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3229987, 47.6052246 ], [ -122.3230281, 47.6051941 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366679, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3231767, 47.6053444 ], [ -122.3231758, 47.6053552 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366680, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323132, 47.6053624 ], [ -122.3231758, 47.6053552 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366681, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323147, 47.6053231 ], [ -122.3231767, 47.6053444 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366682, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3229686, 47.6054256 ], [ -122.3229496, 47.6054207 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366683, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322945, 47.6053931 ], [ -122.3229496, 47.6054207 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366684, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323009, 47.6053994 ], [ -122.3229686, 47.6054256 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366685, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219469, 47.6056786 ], [ -122.3220454, 47.6057832 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366686, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220499, 47.6058174 ], [ -122.3218711, 47.6058827 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366688, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321737, 47.6057408 ], [ -122.3219125, 47.6056675 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366689, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3217021, 47.605765 ], [ -122.3217224, 47.6057417 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366690, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321737, 47.6057408 ], [ -122.3217224, 47.6057417 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366691, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3217185, 47.6057896 ], [ -122.3217021, 47.605765 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366692, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219206, 47.6056566 ], [ -122.3219523, 47.6056619 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366693, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219469, 47.6056786 ], [ -122.3219523, 47.6056619 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366694, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219125, 47.6056675 ], [ -122.3219206, 47.6056566 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366695, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220844, 47.6057852 ], [ -122.3220868, 47.605818 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366696, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220499, 47.6058174 ], [ -122.3220868, 47.605818 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366697, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220454, 47.6057832 ], [ -122.3220844, 47.6057852 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366698, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218595, 47.6058976 ], [ -122.3218102, 47.6058969 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366699, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218037, 47.6058731 ], [ -122.3218102, 47.6058969 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366700, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218711, 47.6058827 ], [ -122.3218595, 47.6058976 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366731, "project_id": 13, "task_id": 451 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3274672, 47.6033594 ], [ -122.3275811, 47.6034725 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366732, "project_id": 13, "task_id": 451 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327453, 47.603332 ], [ -122.3274742, 47.6033497 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366733, "project_id": 13, "task_id": 451 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3274672, 47.6033594 ], [ -122.3274742, 47.6033497 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366735, "project_id": 13, "task_id": 451 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3276041, 47.6034773 ], [ -122.3276103, 47.6034876 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366737, "project_id": 13, "task_id": 451 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275811, 47.6034725 ], [ -122.3276041, 47.6034773 ] ] } }, +{ "type": "Feature", "properties": { "id": 1366738, "project_id": 13, "task_id": 451 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3274133, 47.603543 ], [ -122.3272912, 47.6034065 ] ] } }, +{ "type": "Feature", "properties": { "id": 1368379, "project_id": 14, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3156055, 47.6073973 ], [ -122.3156061, 47.6074647 ] ] } }, +{ "type": "Feature", "properties": { "id": 1368380, "project_id": 14, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155708, 47.6074929 ], [ -122.3153909, 47.6074909 ] ] } }, +{ "type": "Feature", "properties": { "id": 1368381, "project_id": 14, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153903, 47.6073716 ], [ -122.3155685, 47.6073651 ] ] } }, +{ "type": "Feature", "properties": { "id": 1368382, "project_id": 14, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153689, 47.6074992 ], [ -122.3153716, 47.6073546 ] ] } }, +{ "type": "Feature", "properties": { "id": 1368383, "project_id": 14, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153903, 47.6073716 ], [ -122.3153716, 47.6073546 ] ] } }, +{ "type": "Feature", "properties": { "id": 1368384, "project_id": 14, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153909, 47.6074909 ], [ -122.3153689, 47.6074992 ] ] } }, +{ "type": "Feature", "properties": { "id": 1368385, "project_id": 14, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155827, 47.6073639 ], [ -122.3155892, 47.6073814 ] ] } }, +{ "type": "Feature", "properties": { "id": 1368386, "project_id": 14, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3156055, 47.6073973 ], [ -122.3155892, 47.6073814 ] ] } }, +{ "type": "Feature", "properties": { "id": 1368387, "project_id": 14, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155685, 47.6073651 ], [ -122.3155827, 47.6073639 ] ] } }, +{ "type": "Feature", "properties": { "id": 1368388, "project_id": 14, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3156153, 47.6074909 ], [ -122.3155887, 47.6075082 ] ] } }, +{ "type": "Feature", "properties": { "id": 1368389, "project_id": 14, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155708, 47.6074929 ], [ -122.3155887, 47.6075082 ] ] } }, +{ "type": "Feature", "properties": { "id": 1368390, "project_id": 14, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3156061, 47.6074647 ], [ -122.3156153, 47.6074909 ] ] } }, +{ "type": "Feature", "properties": { "id": 1374582, "project_id": 14, "task_id": 430 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166537, 47.6055187 ], [ -122.3166547, 47.6054871 ] ] } }, +{ "type": "Feature", "properties": { "id": 1374584, "project_id": 14, "task_id": 430 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166516, 47.6055316 ], [ -122.3166537, 47.6055187 ] ] } }, +{ "type": "Feature", "properties": { "id": 1374585, "project_id": 14, "task_id": 430 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169379, 47.6056383 ], [ -122.316938, 47.6057855 ] ] } }, +{ "type": "Feature", "properties": { "id": 1374590, "project_id": 14, "task_id": 430 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166549, 47.6056119 ], [ -122.3166465, 47.6056215 ] ] } }, +{ "type": "Feature", "properties": { "id": 1374591, "project_id": 14, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3143049, 47.6055225 ], [ -122.3143018, 47.6056013 ] ] } }, +{ "type": "Feature", "properties": { "id": 1374592, "project_id": 14, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142689, 47.6056133 ], [ -122.3141185, 47.6056117 ] ] } }, +{ "type": "Feature", "properties": { "id": 1374593, "project_id": 14, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3141155, 47.6055008 ], [ -122.3142654, 47.6055084 ] ] } }, +{ "type": "Feature", "properties": { "id": 1374594, "project_id": 14, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140719, 47.6056088 ], [ -122.3140721, 47.6055007 ] ] } }, +{ "type": "Feature", "properties": { "id": 1374595, "project_id": 14, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3141155, 47.6055008 ], [ -122.3140721, 47.6055007 ] ] } }, +{ "type": "Feature", "properties": { "id": 1374596, "project_id": 14, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3141185, 47.6056117 ], [ -122.3140719, 47.6056088 ] ] } }, +{ "type": "Feature", "properties": { "id": 1374598, "project_id": 14, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142689, 47.6056133 ], [ -122.3143012, 47.6056121 ] ] } }, +{ "type": "Feature", "properties": { "id": 1374599, "project_id": 14, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3143018, 47.6056013 ], [ -122.3143012, 47.6056121 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389873, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262002, 47.5999598 ], [ -122.3262529, 47.5999586 ], [ -122.3262539, 47.5999316 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389874, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262788, 47.5999314 ], [ -122.3262539, 47.5999316 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389875, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3261993, 47.5999745 ], [ -122.3262002, 47.5999598 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389876, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264915, 47.5999326 ], [ -122.326492, 47.599958 ], [ -122.3265315, 47.5999572 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389877, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265323, 47.5999736 ], [ -122.3265315, 47.5999572 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389878, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264683, 47.5999323 ], [ -122.3264915, 47.5999326 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389879, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265335, 47.6001188 ], [ -122.3264893, 47.6001207 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389880, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264819, 47.6001098 ], [ -122.3264893, 47.6001207 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389881, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265334, 47.6001025 ], [ -122.3265335, 47.6001188 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389882, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262497, 47.6001176 ], [ -122.3262023, 47.6001159 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389883, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326204, 47.6000982 ], [ -122.3262023, 47.6001159 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389884, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262797, 47.6001152 ], [ -122.3262497, 47.6001176 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389885, "project_id": 14, "task_id": 411 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317075, 47.59995 ], [ -122.3173438, 47.5999828 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389895, "project_id": 14, "task_id": 155 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3161204, 47.6000191 ], [ -122.3161052, 47.6000142 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389899, "project_id": 14, "task_id": 231 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.315903, 47.6001032 ], [ -122.3158789, 47.6001211 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389901, "project_id": 14, "task_id": 148 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140477, 47.5999428 ], [ -122.314256, 47.5999409 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389902, "project_id": 14, "task_id": 148 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142915, 47.5999519 ], [ -122.314295, 47.6000809 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389903, "project_id": 14, "task_id": 148 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314257, 47.6000912 ], [ -122.3140413, 47.6000904 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389904, "project_id": 14, "task_id": 148 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140172, 47.6000677 ], [ -122.31402, 47.599967 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389905, "project_id": 14, "task_id": 148 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140056, 47.6000979 ], [ -122.314005, 47.6000903 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389906, "project_id": 14, "task_id": 148 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140172, 47.6000677 ], [ -122.314005, 47.6000903 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389907, "project_id": 14, "task_id": 148 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140413, 47.6000904 ], [ -122.3140056, 47.6000979 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389908, "project_id": 14, "task_id": 148 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3139871, 47.5999397 ], [ -122.3140011, 47.5999358 ], [ -122.3140063, 47.5999324 ], [ -122.3140084, 47.5999272 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389909, "project_id": 14, "task_id": 148 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140477, 47.5999428 ], [ -122.3140084, 47.5999272 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389910, "project_id": 14, "task_id": 148 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31402, 47.599967 ], [ -122.3139871, 47.5999397 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389911, "project_id": 14, "task_id": 148 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142847, 47.5999293 ], [ -122.3142877, 47.5999364 ], [ -122.3142919, 47.5999398 ], [ -122.3142969, 47.5999419 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389912, "project_id": 14, "task_id": 148 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142915, 47.5999519 ], [ -122.3142969, 47.5999419 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389913, "project_id": 14, "task_id": 148 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314256, 47.5999409 ], [ -122.3142847, 47.5999293 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389917, "project_id": 14, "task_id": 109 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311691, 47.5999546 ], [ -122.3116815, 47.6000652 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389918, "project_id": 14, "task_id": 109 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116511, 47.6000883 ], [ -122.311516, 47.6000864 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389919, "project_id": 14, "task_id": 109 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114833, 47.600063 ], [ -122.3114768, 47.5999475 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389920, "project_id": 14, "task_id": 109 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114985, 47.5999348 ], [ -122.3116668, 47.5999329 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389922, "project_id": 14, "task_id": 109 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114985, 47.5999348 ], [ -122.3114767, 47.5999347 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389923, "project_id": 14, "task_id": 109 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114768, 47.5999475 ], [ -122.3114767, 47.5999347 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389925, "project_id": 14, "task_id": 109 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311691, 47.5999546 ], [ -122.3116978, 47.5999345 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389926, "project_id": 14, "task_id": 109 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116668, 47.5999329 ], [ -122.3116978, 47.5999345 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389927, "project_id": 14, "task_id": 109 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116995, 47.6000895 ], [ -122.3116794, 47.6000956 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389928, "project_id": 14, "task_id": 109 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116511, 47.6000883 ], [ -122.3116794, 47.6000956 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389929, "project_id": 14, "task_id": 109 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116815, 47.6000652 ], [ -122.3116995, 47.6000895 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389930, "project_id": 14, "task_id": 109 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114787, 47.6000907 ], [ -122.311454, 47.600088 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389931, "project_id": 14, "task_id": 109 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114833, 47.600063 ], [ -122.311454, 47.600088 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389932, "project_id": 14, "task_id": 109 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311516, 47.6000864 ], [ -122.3114787, 47.6000907 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389933, "project_id": 14, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310402, 47.5999616 ], [ -122.310395, 47.6000577 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389934, "project_id": 14, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103483, 47.6000852 ], [ -122.310229, 47.6000875 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389935, "project_id": 14, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310178, 47.6000572 ], [ -122.3101807, 47.5999612 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389936, "project_id": 14, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3102253, 47.5999352 ], [ -122.3103462, 47.5999335 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389937, "project_id": 14, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101573, 47.5999345 ], [ -122.3101744, 47.5999258 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389938, "project_id": 14, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3102253, 47.5999352 ], [ -122.3101744, 47.5999258 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389939, "project_id": 14, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101807, 47.5999612 ], [ -122.3101573, 47.5999345 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389940, "project_id": 14, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3104001, 47.5999273 ], [ -122.3104063, 47.5999362 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389941, "project_id": 14, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310402, 47.5999616 ], [ -122.3104063, 47.5999362 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389942, "project_id": 14, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103462, 47.5999335 ], [ -122.3104001, 47.5999273 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389943, "project_id": 14, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3104181, 47.6000883 ], [ -122.3104, 47.6001032 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389944, "project_id": 14, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103483, 47.6000852 ], [ -122.3104, 47.6001032 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389945, "project_id": 14, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310395, 47.6000577 ], [ -122.3104181, 47.6000883 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389946, "project_id": 14, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101733, 47.6001053 ], [ -122.3101502, 47.600087 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389947, "project_id": 14, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310178, 47.6000572 ], [ -122.3101502, 47.600087 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389948, "project_id": 14, "task_id": 201 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310229, 47.6000875 ], [ -122.3101733, 47.6001053 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389949, "project_id": 14, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.309106, 47.5999548 ], [ -122.3091008, 47.6000612 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389950, "project_id": 14, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090647, 47.6000848 ], [ -122.3088974, 47.6000866 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389951, "project_id": 14, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088975, 47.5999383 ], [ -122.3090792, 47.5999349 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389952, "project_id": 14, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088747, 47.6000874 ], [ -122.3088747, 47.5999395 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389953, "project_id": 14, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088975, 47.5999383 ], [ -122.3088747, 47.5999395 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389954, "project_id": 14, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088974, 47.6000866 ], [ -122.3088747, 47.6000874 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389956, "project_id": 14, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.309106, 47.5999548 ], [ -122.3091063, 47.5999312 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389957, "project_id": 14, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090792, 47.5999349 ], [ -122.3091063, 47.5999312 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389959, "project_id": 14, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090647, 47.6000848 ], [ -122.3091001, 47.6000827 ] ] } }, +{ "type": "Feature", "properties": { "id": 1389960, "project_id": 14, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3091008, 47.6000612 ], [ -122.3091001, 47.6000827 ] ] } }, +{ "type": "Feature", "properties": { "id": 1391600, "project_id": 14, "task_id": 108 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3117004, 47.5984034 ], [ -122.3117025, 47.5988631 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408002, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3250199, 47.6073744 ], [ -122.3250893, 47.6074491 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408003, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3250752, 47.6074968 ], [ -122.3249685, 47.6075403 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408004, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3248962, 47.6075322 ], [ -122.3248293, 47.6074556 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408005, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3248483, 47.6074101 ], [ -122.3249582, 47.6073694 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408006, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3248043, 47.6074263 ], [ -122.3248241, 47.6074187 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408007, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3248483, 47.6074101 ], [ -122.3248241, 47.6074187 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408008, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3248293, 47.6074556 ], [ -122.3248043, 47.6074263 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408009, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249832, 47.6073526 ], [ -122.325001, 47.6073552 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408010, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3250199, 47.6073744 ], [ -122.325001, 47.6073552 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408011, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249582, 47.6073694 ], [ -122.3249832, 47.6073526 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408012, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251136, 47.6074712 ], [ -122.3251194, 47.6074777 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408013, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3250752, 47.6074968 ], [ -122.3251194, 47.6074777 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408014, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3250893, 47.6074491 ], [ -122.3251136, 47.6074712 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408016, "project_id": 13, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239305, 47.6078213 ], [ -122.3239086, 47.6078052 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408020, "project_id": 13, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240023, 47.607948 ], [ -122.3240111, 47.6079369 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408021, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3228573, 47.6084223 ], [ -122.3227469, 47.6084676 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408022, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226364, 47.6083524 ], [ -122.3227747, 47.6082874 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408023, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3227747, 47.6082874 ], [ -122.3228735, 47.6083747 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408025, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3227747, 47.6082874 ], [ -122.3227784, 47.6082822 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408026, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3227747, 47.6082874 ], [ -122.3227784, 47.6082822 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408027, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3229038, 47.6084046 ], [ -122.3228992, 47.6084066 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408028, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3228573, 47.6084223 ], [ -122.3228992, 47.6084066 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408029, "project_id": 13, "task_id": 154 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3228735, 47.6083747 ], [ -122.3229038, 47.6084046 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408030, "project_id": 14, "task_id": 84 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3227205, 47.6084773 ], [ -122.3226064, 47.6083656 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408031, "project_id": 14, "task_id": 84 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226364, 47.6083524 ], [ -122.3226064, 47.6083656 ] ] } }, +{ "type": "Feature", "properties": { "id": 1408032, "project_id": 14, "task_id": 84 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3227469, 47.6084676 ], [ -122.3227205, 47.6084773 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414059, "project_id": 14, "task_id": 307 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3148831, 47.6017473 ], [ -122.3146616, 47.6017466 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414062, "project_id": 14, "task_id": 375 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3148689, 47.6016116 ], [ -122.3152348, 47.601614 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414065, "project_id": 14, "task_id": 307 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3150333, 47.6017463 ], [ -122.3150328, 47.6017634 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414068, "project_id": 14, "task_id": 230 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3148973, 47.6027255 ], [ -122.3148898, 47.6026334 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414069, "project_id": 14, "task_id": 230 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3150111, 47.602635 ], [ -122.315019, 47.6027294 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414071, "project_id": 14, "task_id": 230 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3150111, 47.602635 ], [ -122.3148898, 47.6026334 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414072, "project_id": 14, "task_id": 230 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3148898, 47.6026334 ], [ -122.3148811, 47.6026277 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414073, "project_id": 14, "task_id": 230 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3150196, 47.6027511 ], [ -122.3148993, 47.6027505 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414074, "project_id": 14, "task_id": 230 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3148973, 47.6027255 ], [ -122.3148993, 47.6027505 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414075, "project_id": 14, "task_id": 230 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.315019, 47.6027294 ], [ -122.3150196, 47.6027511 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414076, "project_id": 14, "task_id": 393 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155944, 47.606138 ], [ -122.3156043, 47.6062828 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414077, "project_id": 14, "task_id": 393 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.315573, 47.6063014 ], [ -122.315397, 47.606302 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414078, "project_id": 14, "task_id": 393 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153757, 47.6062749 ], [ -122.31538, 47.6061409 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414079, "project_id": 14, "task_id": 393 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3154116, 47.6061108 ], [ -122.3155564, 47.6061091 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414080, "project_id": 14, "task_id": 393 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153786, 47.6061114 ], [ -122.3153933, 47.6061111 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414081, "project_id": 14, "task_id": 393 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3154116, 47.6061108 ], [ -122.3153933, 47.6061111 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414082, "project_id": 14, "task_id": 393 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31538, 47.6061409 ], [ -122.3153786, 47.6061114 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414083, "project_id": 14, "task_id": 393 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155788, 47.6061083 ], [ -122.3155921, 47.606108 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414084, "project_id": 14, "task_id": 393 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155944, 47.606138 ], [ -122.3155921, 47.606108 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414085, "project_id": 14, "task_id": 393 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155564, 47.6061091 ], [ -122.3155788, 47.6061083 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414086, "project_id": 14, "task_id": 393 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3156046, 47.6063003 ], [ -122.3155913, 47.6063012 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414087, "project_id": 14, "task_id": 393 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.315573, 47.6063014 ], [ -122.3155913, 47.6063012 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414088, "project_id": 14, "task_id": 393 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3156043, 47.6062828 ], [ -122.3156046, 47.6063003 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414089, "project_id": 14, "task_id": 393 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153755, 47.6063021 ], [ -122.3153753, 47.6062926 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414090, "project_id": 14, "task_id": 393 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153757, 47.6062749 ], [ -122.3153753, 47.6062926 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414091, "project_id": 14, "task_id": 393 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.315397, 47.606302 ], [ -122.3153755, 47.6063021 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414094, "project_id": 14, "task_id": 331 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155822, 47.6067911 ], [ -122.3155837, 47.6068822 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414095, "project_id": 14, "task_id": 331 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153713, 47.6069088 ], [ -122.315374, 47.6067666 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414098, "project_id": 14, "task_id": 113 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.315367, 47.6091541 ], [ -122.3155583, 47.6091435 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414099, "project_id": 14, "task_id": 113 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155911, 47.6091658 ], [ -122.3155887, 47.6092857 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414100, "project_id": 14, "task_id": 113 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155533, 47.6093158 ], [ -122.315373, 47.6093136 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414102, "project_id": 14, "task_id": 113 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153618, 47.6093135 ], [ -122.3153465, 47.6092983 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414104, "project_id": 14, "task_id": 113 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.315373, 47.6093136 ], [ -122.3153618, 47.6093135 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414105, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142892, 47.6091451 ], [ -122.3153584, 47.6091513 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414106, "project_id": 14, "task_id": 113 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.315367, 47.6091541 ], [ -122.3153584, 47.6091513 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414108, "project_id": 14, "task_id": 113 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155793, 47.6091402 ], [ -122.3155972, 47.6091486 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414109, "project_id": 14, "task_id": 113 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155911, 47.6091658 ], [ -122.3155972, 47.6091486 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414110, "project_id": 14, "task_id": 113 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155583, 47.6091435 ], [ -122.3155793, 47.6091402 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414111, "project_id": 14, "task_id": 113 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3156048, 47.6092937 ], [ -122.3155735, 47.6093113 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414112, "project_id": 14, "task_id": 113 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155533, 47.6093158 ], [ -122.3155735, 47.6093113 ] ] } }, +{ "type": "Feature", "properties": { "id": 1414113, "project_id": 14, "task_id": 113 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155887, 47.6092857 ], [ -122.3156048, 47.6092937 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422418, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195108, 47.6015955 ], [ -122.3196234, 47.6015978 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422419, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319686, 47.6016505 ], [ -122.31968, 47.6017505 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422420, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3196208, 47.6017918 ], [ -122.3195134, 47.6017942 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422421, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194302, 47.6017487 ], [ -122.319434, 47.6016412 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422422, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194777, 47.6017869 ], [ -122.3194282, 47.6017801 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422423, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194302, 47.6017487 ], [ -122.3194282, 47.6017801 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422424, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195134, 47.6017942 ], [ -122.3194777, 47.6017869 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422425, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194349, 47.6016114 ], [ -122.3194359, 47.6015634 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422426, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195108, 47.6015955 ], [ -122.3194359, 47.6015634 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422427, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319434, 47.6016412 ], [ -122.3194349, 47.6016114 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422428, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3196964, 47.6015946 ], [ -122.3196959, 47.6016097 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422429, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319686, 47.6016505 ], [ -122.3196959, 47.6016097 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422430, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3196234, 47.6015978 ], [ -122.3196964, 47.6015946 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422431, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319686, 47.601788 ], [ -122.3196629, 47.6017914 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422432, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3196208, 47.6017918 ], [ -122.3196629, 47.6017914 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422433, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31968, 47.6017505 ], [ -122.319686, 47.601788 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422466, "project_id": 14, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319781, 47.5982937 ], [ -122.319778, 47.5983829 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422467, "project_id": 14, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319717, 47.5984262 ], [ -122.31958, 47.5984222 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422468, "project_id": 14, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319536, 47.598389 ], [ -122.3195231, 47.5982984 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422469, "project_id": 14, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319574, 47.5982656 ], [ -122.319741, 47.5982628 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422470, "project_id": 14, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195183, 47.5982664 ], [ -122.3195492, 47.5982659 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422471, "project_id": 14, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319574, 47.5982656 ], [ -122.3195492, 47.5982659 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422472, "project_id": 14, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195231, 47.5982984 ], [ -122.3195183, 47.5982664 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422473, "project_id": 14, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197708, 47.5982626 ], [ -122.3197819, 47.5982715 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422474, "project_id": 14, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319781, 47.5982937 ], [ -122.3197819, 47.5982715 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422475, "project_id": 14, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319741, 47.5982628 ], [ -122.3197708, 47.5982626 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422476, "project_id": 14, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197759, 47.5984222 ], [ -122.3197756, 47.5984283 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422477, "project_id": 14, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319717, 47.5984262 ], [ -122.3197756, 47.5984283 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422478, "project_id": 14, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319778, 47.5983829 ], [ -122.3197759, 47.5984222 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422479, "project_id": 14, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195343, 47.5984223 ], [ -122.319513, 47.5984221 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422480, "project_id": 14, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319536, 47.598389 ], [ -122.319513, 47.5984221 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422481, "project_id": 14, "task_id": 313 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31958, 47.5984222 ], [ -122.3195343, 47.5984223 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422482, "project_id": 14, "task_id": 18 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195732, 47.5974209 ], [ -122.3197118, 47.5974221 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422483, "project_id": 14, "task_id": 18 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319724, 47.5975985 ], [ -122.3195701, 47.5975964 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422484, "project_id": 14, "task_id": 18 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195489, 47.5975773 ], [ -122.3195561, 47.5974387 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422485, "project_id": 14, "task_id": 18 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195494, 47.5975961 ], [ -122.3195496, 47.5975913 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422486, "project_id": 14, "task_id": 18 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195489, 47.5975773 ], [ -122.3195496, 47.5975913 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422487, "project_id": 14, "task_id": 18 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195701, 47.5975964 ], [ -122.3195494, 47.5975961 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422488, "project_id": 14, "task_id": 18 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195568, 47.5974275 ], [ -122.3195577, 47.5974202 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422489, "project_id": 14, "task_id": 18 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195732, 47.5974209 ], [ -122.3195577, 47.5974202 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422490, "project_id": 14, "task_id": 18 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195561, 47.5974387 ], [ -122.3195568, 47.5974275 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422491, "project_id": 14, "task_id": 18 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197272, 47.5974213 ], [ -122.3197688, 47.5976006 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422492, "project_id": 14, "task_id": 18 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319724, 47.5975985 ], [ -122.3197688, 47.5976006 ] ] } }, +{ "type": "Feature", "properties": { "id": 1422493, "project_id": 14, "task_id": 18 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197118, 47.5974221 ], [ -122.3197272, 47.5974213 ] ] } }, +{ "type": "Feature", "properties": { "id": 1426961, "project_id": 14, "task_id": 372 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142443, 47.6016312 ], [ -122.3142554, 47.601759 ] ] } }, +{ "type": "Feature", "properties": { "id": 1426962, "project_id": 14, "task_id": 372 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314224, 47.6017839 ], [ -122.3140789, 47.6017855 ] ] } }, +{ "type": "Feature", "properties": { "id": 1426963, "project_id": 14, "task_id": 372 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140349, 47.6017547 ], [ -122.3140119, 47.6016228 ] ] } }, +{ "type": "Feature", "properties": { "id": 1426964, "project_id": 14, "task_id": 372 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140373, 47.6016004 ], [ -122.3141957, 47.6016026 ], [ -122.3142969, 47.6015742 ] ] } }, +{ "type": "Feature", "properties": { "id": 1426965, "project_id": 14, "task_id": 372 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140022, 47.6016159 ], [ -122.3140072, 47.6016041 ] ] } }, +{ "type": "Feature", "properties": { "id": 1426966, "project_id": 14, "task_id": 372 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140373, 47.6016004 ], [ -122.3140072, 47.6016041 ] ] } }, +{ "type": "Feature", "properties": { "id": 1426967, "project_id": 14, "task_id": 372 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140119, 47.6016228 ], [ -122.3140022, 47.6016159 ] ] } }, +{ "type": "Feature", "properties": { "id": 1426968, "project_id": 14, "task_id": 372 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3143153, 47.601569 ], [ -122.3143585, 47.6015917 ] ] } }, +{ "type": "Feature", "properties": { "id": 1426969, "project_id": 14, "task_id": 372 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142443, 47.6016312 ], [ -122.3143585, 47.6015917 ] ] } }, +{ "type": "Feature", "properties": { "id": 1426970, "project_id": 14, "task_id": 372 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142969, 47.6015742 ], [ -122.3143153, 47.601569 ] ] } }, +{ "type": "Feature", "properties": { "id": 1426971, "project_id": 14, "task_id": 372 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142719, 47.6017589 ], [ -122.3142684, 47.6017827 ] ] } }, +{ "type": "Feature", "properties": { "id": 1426972, "project_id": 14, "task_id": 372 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314224, 47.6017839 ], [ -122.3142684, 47.6017827 ] ] } }, +{ "type": "Feature", "properties": { "id": 1426973, "project_id": 14, "task_id": 372 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142554, 47.601759 ], [ -122.3142719, 47.6017589 ] ] } }, +{ "type": "Feature", "properties": { "id": 1426974, "project_id": 14, "task_id": 372 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140572, 47.601785 ], [ -122.3140396, 47.6017686 ] ] } }, +{ "type": "Feature", "properties": { "id": 1426975, "project_id": 14, "task_id": 372 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140349, 47.6017547 ], [ -122.3140396, 47.6017686 ] ] } }, +{ "type": "Feature", "properties": { "id": 1426976, "project_id": 14, "task_id": 372 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140789, 47.6017855 ], [ -122.3140572, 47.601785 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440355, "project_id": 14, "task_id": 337 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169471, 47.6016356 ], [ -122.3169395, 47.6017636 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440356, "project_id": 14, "task_id": 337 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316902, 47.6017883 ], [ -122.316677, 47.6017773 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440357, "project_id": 14, "task_id": 337 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166461, 47.6017591 ], [ -122.316648, 47.6016342 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440358, "project_id": 14, "task_id": 337 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316684, 47.6016152 ], [ -122.3169035, 47.6016098 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440359, "project_id": 14, "task_id": 337 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166482, 47.601618 ], [ -122.3166678, 47.6016163 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440360, "project_id": 14, "task_id": 337 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316684, 47.6016152 ], [ -122.3166678, 47.6016163 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440361, "project_id": 14, "task_id": 337 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316648, 47.6016342 ], [ -122.3166482, 47.601618 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440362, "project_id": 14, "task_id": 338 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169456, 47.6016077 ], [ -122.3169458, 47.6016177 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440363, "project_id": 14, "task_id": 338 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169471, 47.6016356 ], [ -122.3169458, 47.6016177 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440364, "project_id": 14, "task_id": 338 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169035, 47.6016098 ], [ -122.3169456, 47.6016077 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440365, "project_id": 14, "task_id": 337 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316943, 47.6017729 ], [ -122.31692, 47.6017886 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440366, "project_id": 14, "task_id": 337 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316902, 47.6017883 ], [ -122.31692, 47.6017886 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440367, "project_id": 14, "task_id": 337 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169395, 47.6017636 ], [ -122.316943, 47.6017729 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440368, "project_id": 14, "task_id": 337 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166583, 47.6017769 ], [ -122.3166457, 47.6017652 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440369, "project_id": 14, "task_id": 337 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166461, 47.6017591 ], [ -122.3166457, 47.6017652 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440370, "project_id": 14, "task_id": 337 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316677, 47.6017773 ], [ -122.3166583, 47.6017769 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440371, "project_id": 14, "task_id": 63 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317382, 47.5983028 ], [ -122.317385, 47.5983945 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440372, "project_id": 14, "task_id": 63 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317343, 47.5984366 ], [ -122.317142, 47.5984252 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440373, "project_id": 14, "task_id": 63 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317116, 47.5983918 ], [ -122.317138, 47.5982774 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440374, "project_id": 14, "task_id": 63 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317138, 47.5982774 ], [ -122.317341, 47.5982722 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440375, "project_id": 14, "task_id": 63 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3170754, 47.5982678 ], [ -122.3171253, 47.5982681 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440376, "project_id": 14, "task_id": 63 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317138, 47.5982774 ], [ -122.3171253, 47.5982681 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440378, "project_id": 14, "task_id": 63 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173593, 47.5982708 ], [ -122.3173814, 47.5982691 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440379, "project_id": 14, "task_id": 63 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317382, 47.5983028 ], [ -122.3173814, 47.5982691 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440380, "project_id": 14, "task_id": 63 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317341, 47.5982722 ], [ -122.3173593, 47.5982708 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440381, "project_id": 14, "task_id": 63 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173854, 47.5984215 ], [ -122.3173642, 47.5984245 ], [ -122.3173552, 47.5984374 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440382, "project_id": 14, "task_id": 63 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317343, 47.5984366 ], [ -122.3173552, 47.5984374 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440383, "project_id": 14, "task_id": 63 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317385, 47.5983945 ], [ -122.3173854, 47.5984215 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440384, "project_id": 14, "task_id": 63 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3171234, 47.598424 ], [ -122.3171171, 47.598417 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440385, "project_id": 14, "task_id": 63 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317116, 47.5983918 ], [ -122.3171171, 47.598417 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440386, "project_id": 14, "task_id": 63 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317142, 47.5984252 ], [ -122.3171234, 47.598424 ] ] } }, +{ "type": "Feature", "properties": { "id": 1440387, "project_id": 14, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317345, 47.5975953 ], [ -122.317146, 47.5975836 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441863, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236515, 47.5984684 ], [ -122.3236515, 47.5984357 ], [ -122.3235973, 47.5984358 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441864, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235971, 47.5984198 ], [ -122.3235973, 47.5984358 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441865, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236683, 47.5984683 ], [ -122.3236515, 47.5984684 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441866, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235944, 47.5982803 ], [ -122.3236468, 47.5982739 ], [ -122.3236506, 47.5982316 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441868, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235946, 47.5982914 ], [ -122.3235944, 47.5982803 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441869, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238834, 47.5982376 ], [ -122.3238839, 47.5982793 ], [ -122.323917, 47.5982801 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441871, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238648, 47.5982426 ], [ -122.3238834, 47.5982376 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441872, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223455, 47.598454 ], [ -122.3223446, 47.5984299 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441873, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322341, 47.5984045 ], [ -122.3223446, 47.5984299 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441874, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322377, 47.5984541 ], [ -122.3223455, 47.598454 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441875, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223259, 47.5982769 ], [ -122.3223457, 47.5982631 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441876, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322388, 47.5982726 ], [ -122.3223457, 47.5982631 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441877, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322337, 47.5983054 ], [ -122.3223259, 47.5982769 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441878, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322578, 47.5982669 ], [ -122.3225782, 47.5982798 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441879, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322578, 47.5982966 ], [ -122.3225782, 47.5982798 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441880, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322543, 47.5982668 ], [ -122.322578, 47.5982669 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441881, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322587, 47.5984361 ], [ -122.3225735, 47.5984479 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441882, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322529, 47.5984401 ], [ -122.3225735, 47.5984479 ] ] } }, +{ "type": "Feature", "properties": { "id": 1441883, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322587, 47.5984045 ], [ -122.322587, 47.5984361 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443171, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265237, 47.6008244 ], [ -122.32652, 47.6009305 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443184, "project_id": 14, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129563, 47.600922 ], [ -122.3128344, 47.6009241 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443185, "project_id": 14, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127845, 47.6009016 ], [ -122.3127794, 47.6008026 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443186, "project_id": 14, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.313001, 47.6008042 ], [ -122.3129981, 47.6008998 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443187, "project_id": 14, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.312778, 47.6007775 ], [ -122.313, 47.6007787 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443188, "project_id": 14, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.313001, 47.6008042 ], [ -122.313, 47.6007787 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443189, "project_id": 14, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127794, 47.6008026 ], [ -122.312778, 47.6007775 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443190, "project_id": 14, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127917, 47.600942 ], [ -122.3127687, 47.6009279 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443191, "project_id": 14, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127845, 47.6009016 ], [ -122.3127687, 47.6009279 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443192, "project_id": 14, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3128344, 47.6009241 ], [ -122.3127917, 47.600942 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443193, "project_id": 14, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3117103, 47.6008033 ], [ -122.3117036, 47.6008985 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443194, "project_id": 14, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116623, 47.6009254 ], [ -122.3115217, 47.6009302 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443195, "project_id": 14, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3115026, 47.6009089 ], [ -122.3114845, 47.6007991 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443196, "project_id": 14, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3115143, 47.6007785 ], [ -122.3116668, 47.6007786 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443198, "project_id": 14, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3115143, 47.6007785 ], [ -122.3114822, 47.6007737 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443199, "project_id": 14, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114845, 47.6007991 ], [ -122.3114822, 47.6007737 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443201, "project_id": 14, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3117103, 47.6008033 ], [ -122.3117088, 47.6007783 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443202, "project_id": 14, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116668, 47.6007786 ], [ -122.3117088, 47.6007783 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443204, "project_id": 14, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116623, 47.6009254 ], [ -122.3116996, 47.6009267 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443205, "project_id": 14, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3117036, 47.6008985 ], [ -122.3116996, 47.6009267 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443206, "project_id": 14, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114818, 47.600931 ], [ -122.3114805, 47.6009247 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443207, "project_id": 14, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3115026, 47.6009089 ], [ -122.3114805, 47.6009247 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443208, "project_id": 14, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3115217, 47.6009302 ], [ -122.3114818, 47.600931 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443209, "project_id": 14, "task_id": 143 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090642, 47.6009245 ], [ -122.3089022, 47.6009212 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443210, "project_id": 14, "task_id": 143 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3089039, 47.6007646 ], [ -122.3090555, 47.600763 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443211, "project_id": 14, "task_id": 143 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3091206, 47.6007967 ], [ -122.3091207, 47.600893 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443212, "project_id": 14, "task_id": 143 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090779, 47.6007637 ], [ -122.3091219, 47.6007706 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443213, "project_id": 14, "task_id": 143 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3091206, 47.6007967 ], [ -122.3091219, 47.6007706 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443214, "project_id": 14, "task_id": 143 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090555, 47.600763 ], [ -122.3090779, 47.6007637 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443215, "project_id": 14, "task_id": 143 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088674, 47.6009219 ], [ -122.308868, 47.600765 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443216, "project_id": 14, "task_id": 143 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3089039, 47.6007646 ], [ -122.308868, 47.600765 ] ] } }, +{ "type": "Feature", "properties": { "id": 1443217, "project_id": 14, "task_id": 143 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3089022, 47.6009212 ], [ -122.3088674, 47.6009219 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476315, "project_id": 14, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316934, 47.602643 ], [ -122.3169437, 47.6027307 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476316, "project_id": 14, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169109, 47.6027522 ], [ -122.316677, 47.6027527 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476317, "project_id": 14, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316647, 47.6027323 ], [ -122.316649, 47.6026503 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476318, "project_id": 14, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166835, 47.6026283 ], [ -122.3169137, 47.6026275 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476319, "project_id": 14, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166441, 47.6026395 ], [ -122.316662, 47.6026201 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476320, "project_id": 14, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166835, 47.6026283 ], [ -122.316662, 47.6026201 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476322, "project_id": 14, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169397, 47.6026193 ], [ -122.316944, 47.6026295 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476323, "project_id": 14, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316934, 47.602643 ], [ -122.316944, 47.6026295 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476324, "project_id": 14, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169137, 47.6026275 ], [ -122.3169397, 47.6026193 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476326, "project_id": 14, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316647, 47.6027323 ], [ -122.3166379, 47.6027519 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476328, "project_id": 14, "task_id": 311 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316945, 47.603474 ], [ -122.3169433, 47.6035615 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476329, "project_id": 14, "task_id": 311 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316914, 47.6035803 ], [ -122.316682, 47.6035826 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476330, "project_id": 14, "task_id": 311 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316626, 47.6035574 ], [ -122.316628, 47.6034802 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476331, "project_id": 14, "task_id": 311 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316673, 47.6034617 ], [ -122.31692, 47.6034564 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476332, "project_id": 14, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169222, 47.6042745 ], [ -122.3169329, 47.6042799 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476333, "project_id": 14, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169474, 47.6043189 ], [ -122.3169329, 47.6042799 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476334, "project_id": 14, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3168859, 47.6042784 ], [ -122.3169222, 47.6042745 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476335, "project_id": 14, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31694, 47.6044327 ], [ -122.3169257, 47.6044381 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476336, "project_id": 14, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3168862, 47.6044313 ], [ -122.3169257, 47.6044381 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476337, "project_id": 14, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169271, 47.6043919 ], [ -122.31694, 47.6044327 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476338, "project_id": 14, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316638, 47.6044152 ], [ -122.316639, 47.6042731 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476339, "project_id": 14, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166736, 47.6042724 ], [ -122.316639, 47.6042731 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476340, "project_id": 14, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166717, 47.6044165 ], [ -122.316638, 47.6044152 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476342, "project_id": 14, "task_id": 392 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166844, 47.6051227 ], [ -122.3169091, 47.6051345 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476343, "project_id": 14, "task_id": 392 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169356, 47.6051566 ], [ -122.316934, 47.6052455 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476344, "project_id": 14, "task_id": 392 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169383, 47.6052704 ], [ -122.3169389, 47.6053078 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476346, "project_id": 14, "task_id": 392 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316934, 47.6052455 ], [ -122.3169383, 47.6052704 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476347, "project_id": 14, "task_id": 392 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166528, 47.6052704 ], [ -122.316652, 47.6051223 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476348, "project_id": 14, "task_id": 392 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166844, 47.6051227 ], [ -122.316652, 47.6051223 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476350, "project_id": 14, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169674, 47.6061468 ], [ -122.3169664, 47.6062737 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476351, "project_id": 14, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3168997, 47.6063054 ], [ -122.3167058, 47.6062984 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476352, "project_id": 14, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316643, 47.6062699 ], [ -122.316643, 47.6061434 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476353, "project_id": 14, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166968, 47.6061145 ], [ -122.3169112, 47.6061282 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476354, "project_id": 14, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166425, 47.6061136 ], [ -122.3166612, 47.6061079 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476355, "project_id": 14, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166968, 47.6061145 ], [ -122.3166612, 47.6061079 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476356, "project_id": 14, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316643, 47.6061434 ], [ -122.3166425, 47.6061136 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476357, "project_id": 14, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169651, 47.6062854 ], [ -122.3169343, 47.6063081 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476358, "project_id": 14, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3168997, 47.6063054 ], [ -122.3169343, 47.6063081 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476359, "project_id": 14, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169664, 47.6062737 ], [ -122.3169651, 47.6062854 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476360, "project_id": 14, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166717, 47.6063019 ], [ -122.3166449, 47.6062905 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476361, "project_id": 14, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316643, 47.6062699 ], [ -122.3166449, 47.6062905 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476362, "project_id": 14, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3167058, 47.6062984 ], [ -122.3166717, 47.6063019 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476364, "project_id": 14, "task_id": 332 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166391, 47.6068723 ], [ -122.3166559, 47.6068035 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476368, "project_id": 14, "task_id": 332 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166559, 47.6068035 ], [ -122.316656, 47.60679 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476372, "project_id": 14, "task_id": 332 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316641, 47.6069174 ], [ -122.3166343, 47.6068948 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476373, "project_id": 14, "task_id": 332 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166391, 47.6068723 ], [ -122.3166343, 47.6068948 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476375, "project_id": 14, "task_id": 206 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166548, 47.6092943 ], [ -122.3166449, 47.6091693 ] ] } }, +{ "type": "Feature", "properties": { "id": 1476376, "project_id": 14, "task_id": 58 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166441, 47.6104542 ], [ -122.3166421, 47.6103369 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485712, "project_id": 14, "task_id": 226 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3102177, 47.6016119 ], [ -122.3103495, 47.601613 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485713, "project_id": 14, "task_id": 226 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103964, 47.6016388 ], [ -122.3103972, 47.6017479 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485714, "project_id": 14, "task_id": 226 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103455, 47.6017599 ], [ -122.310219, 47.6017579 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485715, "project_id": 14, "task_id": 226 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101546, 47.6017314 ], [ -122.3101552, 47.6016415 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485717, "project_id": 14, "task_id": 226 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101546, 47.6017314 ], [ -122.3101574, 47.6017615 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485718, "project_id": 14, "task_id": 226 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310219, 47.6017579 ], [ -122.3101574, 47.6017615 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485720, "project_id": 14, "task_id": 226 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3102177, 47.6016119 ], [ -122.3101592, 47.6016129 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485721, "project_id": 14, "task_id": 226 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101552, 47.6016415 ], [ -122.3101592, 47.6016129 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485723, "project_id": 14, "task_id": 226 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103964, 47.6016388 ], [ -122.3103963, 47.6016123 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485724, "project_id": 14, "task_id": 226 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103495, 47.601613 ], [ -122.3103963, 47.6016123 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485725, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3100868, 47.6027524 ], [ -122.3100675, 47.6027416 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485726, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101, 47.6027201 ], [ -122.3100675, 47.6027416 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485727, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101344, 47.6027427 ], [ -122.3100868, 47.6027524 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485728, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101284, 47.602622 ], [ -122.3101689, 47.6026008 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485729, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310207, 47.6026065 ], [ -122.3101689, 47.6026008 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485730, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310144, 47.6026436 ], [ -122.3101284, 47.602622 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485731, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103598, 47.6026043 ], [ -122.3103724, 47.6026226 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485732, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103521, 47.6026331 ], [ -122.3103724, 47.6026226 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485733, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310334, 47.6026112 ], [ -122.3103598, 47.6026043 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485734, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103387, 47.6027423 ], [ -122.310311, 47.6027554 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485735, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3102881, 47.6027435 ], [ -122.310311, 47.6027554 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485736, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103301, 47.6027234 ], [ -122.3103387, 47.6027423 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485737, "project_id": 14, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31021, 47.6060875 ], [ -122.310321, 47.6060899 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485738, "project_id": 14, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310366, 47.6061183 ], [ -122.31036, 47.6062253 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485739, "project_id": 14, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310164, 47.6062256 ], [ -122.310153, 47.6061192 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485741, "project_id": 14, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31021, 47.6060875 ], [ -122.310151, 47.6060859 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485742, "project_id": 14, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310153, 47.6061192 ], [ -122.310151, 47.6060859 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485744, "project_id": 14, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310366, 47.6061183 ], [ -122.3103756, 47.6060933 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485745, "project_id": 14, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310321, 47.6060899 ], [ -122.3103756, 47.6060933 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485746, "project_id": 14, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103116, 47.6062781 ], [ -122.3102083, 47.6062771 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485747, "project_id": 14, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310164, 47.6062256 ], [ -122.3101614, 47.6062766 ] ] } }, +{ "type": "Feature", "properties": { "id": 1485748, "project_id": 14, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31036, 47.6062253 ], [ -122.3103591, 47.6062786 ] ] } }, +{ "type": "Feature", "properties": { "id": 1503959, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323867, 47.5976163 ], [ -122.323671, 47.5976178 ] ] } }, +{ "type": "Feature", "properties": { "id": 1503960, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323594, 47.5975828 ], [ -122.323605, 47.5974487 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507682, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326579, 47.6057251 ], [ -122.3266501, 47.6058077 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507683, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3266545, 47.6058608 ], [ -122.3265445, 47.6059042 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507684, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264553, 47.6058865 ], [ -122.3263849, 47.6058109 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507685, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3263805, 47.6057572 ], [ -122.3264919, 47.6057115 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507686, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3263367, 47.6057872 ], [ -122.3263517, 47.6057614 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507687, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3263805, 47.6057572 ], [ -122.3263517, 47.6057614 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507688, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3263849, 47.6058109 ], [ -122.3263367, 47.6057872 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507689, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265247, 47.6056941 ], [ -122.3265628, 47.6057047 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507690, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326579, 47.6057251 ], [ -122.3265628, 47.6057047 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507691, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264919, 47.6057115 ], [ -122.3265247, 47.6056941 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507692, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3266778, 47.6058356 ], [ -122.3266726, 47.6058582 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507693, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3266545, 47.6058608 ], [ -122.3266726, 47.6058582 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507694, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3266501, 47.6058077 ], [ -122.3266778, 47.6058356 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507695, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264862, 47.6059385 ], [ -122.3264619, 47.605932 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507696, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264553, 47.6058865 ], [ -122.3264619, 47.605932 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507697, "project_id": 13, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265445, 47.6059042 ], [ -122.3264862, 47.6059385 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507698, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3243635, 47.6066625 ], [ -122.3244235, 47.6067417 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507699, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3244091, 47.6067663 ], [ -122.324248, 47.606816 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507701, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3241891, 47.6066954 ], [ -122.3243012, 47.6066493 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507703, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3241891, 47.6066954 ], [ -122.32415, 47.6067105 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507704, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3241753, 47.6067358 ], [ -122.32415, 47.6067105 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507705, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3243377, 47.6066339 ], [ -122.3243635, 47.6066625 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507707, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3243012, 47.6066493 ], [ -122.3243377, 47.6066339 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507709, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3244091, 47.6067663 ], [ -122.3244362, 47.606755 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507710, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3244235, 47.6067417 ], [ -122.3244362, 47.606755 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507711, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3242547, 47.6068229 ], [ -122.324248, 47.606816 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507712, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3241753, 47.6067358 ], [ -122.324248, 47.606816 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507713, "project_id": 13, "task_id": 405 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324248, 47.606816 ], [ -122.3242547, 47.6068229 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507714, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3221564, 47.6075823 ], [ -122.3222376, 47.6076727 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507715, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3222296, 47.6077046 ], [ -122.322082, 47.6077684 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507716, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220248, 47.6077622 ], [ -122.3219577, 47.6076687 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507717, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219735, 47.607625 ], [ -122.322087, 47.6075787 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507719, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219735, 47.607625 ], [ -122.3219316, 47.6076415 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507720, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219577, 47.6076687 ], [ -122.3219316, 47.6076415 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507721, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220995, 47.6075722 ], [ -122.3221037, 47.6075753 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507722, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3221564, 47.6075823 ], [ -122.322131, 47.6075828 ], [ -122.3221154, 47.6075808 ], [ -122.3221037, 47.6075753 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507723, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322087, 47.6075787 ], [ -122.3220995, 47.6075722 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507724, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3222505, 47.607686 ], [ -122.3222377, 47.607697 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507725, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3222296, 47.6077046 ], [ -122.3222377, 47.607697 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507726, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3222376, 47.6076727 ], [ -122.3222505, 47.607686 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507727, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220682, 47.6077808 ], [ -122.3220405, 47.6077797 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507728, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220248, 47.6077622 ], [ -122.3220405, 47.6077797 ] ] } }, +{ "type": "Feature", "properties": { "id": 1507729, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322082, 47.6077684 ], [ -122.3220682, 47.6077808 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508660, "project_id": 13, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195359, 47.6043241 ], [ -122.319549, 47.6044015 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508661, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194932, 47.60444 ], [ -122.3193633, 47.6044387 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508662, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193235, 47.6044045 ], [ -122.3193333, 47.604317 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508663, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193605, 47.604289 ], [ -122.3194958, 47.6043034 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508664, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193219, 47.604289 ], [ -122.3193294, 47.6042809 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508665, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193605, 47.604289 ], [ -122.3193294, 47.6042809 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508666, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193333, 47.604317 ], [ -122.3193219, 47.604289 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508667, "project_id": 13, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195221, 47.6042938 ], [ -122.3195492, 47.6043015 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508668, "project_id": 13, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195359, 47.6043241 ], [ -122.3195492, 47.6043015 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508669, "project_id": 13, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194958, 47.6043034 ], [ -122.3195221, 47.6042938 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508670, "project_id": 13, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195612, 47.6044282 ], [ -122.3195249, 47.604451 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508671, "project_id": 13, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194932, 47.60444 ], [ -122.3195249, 47.604451 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508672, "project_id": 13, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319549, 47.6044015 ], [ -122.3195612, 47.6044282 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508673, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193313, 47.6044417 ], [ -122.3193162, 47.6044402 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508674, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193235, 47.6044045 ], [ -122.3193162, 47.6044402 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508675, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193633, 47.6044387 ], [ -122.3193313, 47.6044417 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508676, "project_id": 13, "task_id": 41 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195003, 47.6051447 ], [ -122.3194996, 47.6052426 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508677, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194708, 47.6052668 ], [ -122.3193569, 47.6052665 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508678, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193313, 47.6052472 ], [ -122.3193323, 47.6051621 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508679, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193571, 47.6051235 ], [ -122.3194985, 47.6051224 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508680, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193322, 47.6051368 ], [ -122.319332, 47.6051319 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508681, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193571, 47.6051235 ], [ -122.319332, 47.6051319 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508682, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193323, 47.6051621 ], [ -122.3193322, 47.6051368 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508683, "project_id": 13, "task_id": 41 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195235, 47.6051148 ], [ -122.3195232, 47.6051325 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508684, "project_id": 13, "task_id": 41 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195003, 47.6051447 ], [ -122.3195232, 47.6051325 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508685, "project_id": 13, "task_id": 41 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194985, 47.6051224 ], [ -122.3195235, 47.6051148 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508686, "project_id": 13, "task_id": 41 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194992, 47.6052565 ], [ -122.3194979, 47.6052714 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508687, "project_id": 13, "task_id": 41 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194708, 47.6052668 ], [ -122.3194979, 47.6052714 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508688, "project_id": 13, "task_id": 41 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194996, 47.6052426 ], [ -122.3194992, 47.6052565 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508689, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319333, 47.6052722 ], [ -122.3193336, 47.6052681 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508690, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193313, 47.6052472 ], [ -122.3193336, 47.6052681 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508691, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193569, 47.6052665 ], [ -122.319333, 47.6052722 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508692, "project_id": 14, "task_id": 389 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195166, 47.6061532 ], [ -122.3195177, 47.6062726 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508694, "project_id": 14, "task_id": 389 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193634, 47.6061419 ], [ -122.319513, 47.6061405 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508695, "project_id": 14, "task_id": 389 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192854, 47.6061405 ], [ -122.3193447, 47.6061405 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508696, "project_id": 14, "task_id": 389 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193634, 47.6061419 ], [ -122.3193447, 47.6061405 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508698, "project_id": 14, "task_id": 389 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195195, 47.6062902 ], [ -122.3192898, 47.6062904 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508700, "project_id": 14, "task_id": 389 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195177, 47.6062726 ], [ -122.3195195, 47.6062902 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508703, "project_id": 13, "task_id": 135 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3189565, 47.6026266 ], [ -122.3193197, 47.6026332 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508706, "project_id": 13, "task_id": 135 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193018, 47.602758 ], [ -122.3192726, 47.6027593 ], [ -122.3190795, 47.6027616 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508780, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195554, 47.602662 ], [ -122.3195567, 47.6027345 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508781, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193283, 47.6027463 ], [ -122.3193219, 47.6026542 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508782, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319369, 47.6026281 ], [ -122.3194808, 47.6026216 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508783, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193197, 47.6026332 ], [ -122.3193423, 47.6026286 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508784, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319369, 47.6026281 ], [ -122.3193423, 47.6026286 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508785, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193219, 47.6026542 ], [ -122.3193197, 47.6026332 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508786, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319524, 47.6026219 ], [ -122.3195586, 47.6026425 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508787, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195554, 47.602662 ], [ -122.3195586, 47.6026425 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508788, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194808, 47.6026216 ], [ -122.319524, 47.6026219 ] ] } }, +{ "type": "Feature", "properties": { "id": 1508791, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195567, 47.6027345 ], [ -122.3195588, 47.6027562 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509737, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260066, 47.6051541 ], [ -122.3258884, 47.605197 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509738, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3258283, 47.605186 ], [ -122.3257445, 47.6050492 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509739, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3258609, 47.605001 ], [ -122.3260177, 47.6051085 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509740, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3257445, 47.6050492 ], [ -122.3258609, 47.605001 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509741, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3258609, 47.605001 ], [ -122.3258866, 47.6049807 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509742, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3257445, 47.6050492 ], [ -122.3257159, 47.6050568 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509743, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260443, 47.6051085 ], [ -122.3260408, 47.6051522 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509744, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260066, 47.6051541 ], [ -122.3260408, 47.6051522 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509745, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260177, 47.6051085 ], [ -122.3260443, 47.6051085 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509746, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3258714, 47.6052132 ], [ -122.3258288, 47.6051977 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509747, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3258283, 47.605186 ], [ -122.3258288, 47.6051977 ] ] } }, +{ "type": "Feature", "properties": { "id": 1509748, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3258884, 47.605197 ], [ -122.3258714, 47.6052132 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511678, "project_id": 14, "task_id": 234 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317731, 47.6017605 ], [ -122.317569, 47.6016288 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511679, "project_id": 14, "task_id": 234 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317588, 47.6016024 ], [ -122.317888, 47.6016119 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511680, "project_id": 14, "task_id": 345 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3175587, 47.6016207 ], [ -122.3175737, 47.6016116 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511681, "project_id": 14, "task_id": 345 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317588, 47.6016024 ], [ -122.3175737, 47.6016116 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511682, "project_id": 14, "task_id": 345 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317569, 47.6016288 ], [ -122.3175587, 47.6016207 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511683, "project_id": 14, "task_id": 342 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180665, 47.6017795 ], [ -122.3177835, 47.6017789 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511684, "project_id": 14, "task_id": 234 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317731, 47.6017605 ], [ -122.3177555, 47.6017791 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511685, "project_id": 14, "task_id": 234 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3179054, 47.601603 ], [ -122.3179213, 47.6016161 ], [ -122.317936, 47.6016225 ], [ -122.3179915, 47.601621 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511688, "project_id": 13, "task_id": 135 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3189717, 47.6026479 ], [ -122.3190244, 47.6027069 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511689, "project_id": 13, "task_id": 138 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3189173, 47.6026037 ], [ -122.3189565, 47.6026266 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511690, "project_id": 13, "task_id": 138 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3189717, 47.6026479 ], [ -122.3189565, 47.6026266 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511692, "project_id": 13, "task_id": 135 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3190502, 47.6027335 ], [ -122.3190795, 47.6027616 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511694, "project_id": 13, "task_id": 135 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3190244, 47.6027069 ], [ -122.3190502, 47.6027335 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511695, "project_id": 13, "task_id": 138 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3188753, 47.6028355 ], [ -122.3187193, 47.6026956 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511699, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3204661, 47.6044092 ], [ -122.3204242, 47.6043561 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511701, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3203737, 47.6043137 ], [ -122.3203599, 47.6042815 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511703, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3204242, 47.6043561 ], [ -122.3203737, 47.6043137 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511704, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3205567, 47.6041954 ], [ -122.3206238, 47.6042632 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511707, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3205634, 47.604478 ], [ -122.320522, 47.6044453 ], [ -122.3204962, 47.6044329 ], [ -122.320456, 47.6044261 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511708, "project_id": 13, "task_id": 267 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3204661, 47.6044092 ], [ -122.320456, 47.6044261 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511710, "project_id": 13, "task_id": 266 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3213934, 47.6050972 ], [ -122.321216, 47.6051636 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511712, "project_id": 13, "task_id": 266 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3213199, 47.6049541 ], [ -122.321404, 47.6050627 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511713, "project_id": 13, "task_id": 266 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3212711, 47.6049394 ], [ -122.3213199, 47.6049314 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511714, "project_id": 13, "task_id": 266 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3213199, 47.6049541 ], [ -122.3213199, 47.6049314 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511716, "project_id": 13, "task_id": 266 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214243, 47.6050723 ], [ -122.3214155, 47.6050952 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511717, "project_id": 13, "task_id": 266 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3213934, 47.6050972 ], [ -122.3214155, 47.6050952 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511718, "project_id": 13, "task_id": 266 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321404, 47.6050627 ], [ -122.3214243, 47.6050723 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511719, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3211996, 47.605171 ], [ -122.3209159, 47.6048634 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511721, "project_id": 13, "task_id": 266 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321216, 47.6051636 ], [ -122.3211996, 47.605171 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511722, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226027, 47.6063613 ], [ -122.322728, 47.6065355 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511723, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3224815, 47.6066156 ], [ -122.3223587, 47.6064522 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511724, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223581, 47.6064161 ], [ -122.3225372, 47.6063461 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511725, "project_id": 13, "task_id": 159 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223337, 47.6064507 ], [ -122.3223325, 47.6064166 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511726, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223581, 47.6064161 ], [ -122.3223325, 47.6064166 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511727, "project_id": 13, "task_id": 159 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223587, 47.6064522 ], [ -122.3223337, 47.6064507 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511728, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225611, 47.6063333 ], [ -122.322598, 47.6063381 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511729, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226027, 47.6063613 ], [ -122.322598, 47.6063381 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511730, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225372, 47.6063461 ], [ -122.3225611, 47.6063333 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511731, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322728, 47.6065355 ], [ -122.3225282, 47.6066218 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511732, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3224815, 47.6066156 ], [ -122.322474, 47.6066287 ] ] } }, +{ "type": "Feature", "properties": { "id": 1511733, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322728, 47.6065355 ], [ -122.3227562, 47.6065115 ] ] } }, +{ "type": "Feature", "properties": { "id": 1524864, "project_id": 14, "task_id": 258 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140833, 47.6043951 ], [ -122.314089, 47.6043148 ] ] } }, +{ "type": "Feature", "properties": { "id": 1524865, "project_id": 14, "task_id": 258 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3141492, 47.604277 ], [ -122.3142608, 47.6042668 ] ] } }, +{ "type": "Feature", "properties": { "id": 1524866, "project_id": 14, "task_id": 258 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142578, 47.6044233 ], [ -122.3141255, 47.6044261 ] ] } }, +{ "type": "Feature", "properties": { "id": 1524867, "project_id": 14, "task_id": 258 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314083, 47.6044267 ], [ -122.3140827, 47.6044161 ] ] } }, +{ "type": "Feature", "properties": { "id": 1524868, "project_id": 14, "task_id": 258 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140833, 47.6043951 ], [ -122.3140827, 47.6044161 ] ] } }, +{ "type": "Feature", "properties": { "id": 1524869, "project_id": 14, "task_id": 258 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3141255, 47.6044261 ], [ -122.314083, 47.6044267 ] ] } }, +{ "type": "Feature", "properties": { "id": 1524870, "project_id": 14, "task_id": 258 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3143036, 47.604261 ], [ -122.3143076, 47.6044232 ] ] } }, +{ "type": "Feature", "properties": { "id": 1524871, "project_id": 14, "task_id": 258 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142578, 47.6044233 ], [ -122.3143076, 47.6044232 ] ] } }, +{ "type": "Feature", "properties": { "id": 1524872, "project_id": 14, "task_id": 258 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142608, 47.6042668 ], [ -122.3143036, 47.604261 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529966, "project_id": 14, "task_id": 83 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3234492, 47.6090056 ], [ -122.3235596, 47.6091008 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529968, "project_id": 14, "task_id": 83 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3233273, 47.6091784 ], [ -122.3232578, 47.6090976 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529969, "project_id": 14, "task_id": 83 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3232674, 47.6090464 ], [ -122.3233859, 47.6089998 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529970, "project_id": 14, "task_id": 83 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3232046, 47.60907 ], [ -122.3232076, 47.6090564 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529971, "project_id": 14, "task_id": 83 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3232674, 47.6090464 ], [ -122.3232076, 47.6090564 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529972, "project_id": 14, "task_id": 83 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3232578, 47.6090976 ], [ -122.3232046, 47.60907 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529973, "project_id": 14, "task_id": 83 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3234091, 47.6089768 ], [ -122.3234335, 47.608978 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529974, "project_id": 14, "task_id": 83 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3234492, 47.6090056 ], [ -122.3234335, 47.608978 ] ] } }, +{ "type": "Feature", "properties": { "id": 1529975, "project_id": 14, "task_id": 83 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3233859, 47.6089998 ], [ -122.3234091, 47.6089768 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530546, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327141, 47.6046801 ], [ -122.326969, 47.6047364 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530547, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326969, 47.6047364 ], [ -122.3268171, 47.6045994 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530548, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3268389, 47.6045693 ], [ -122.3269883, 47.604509 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530549, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3268017, 47.6045848 ], [ -122.3268193, 47.604577 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530550, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3268389, 47.6045693 ], [ -122.3268193, 47.604577 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530551, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3268171, 47.6045994 ], [ -122.3268017, 47.6045848 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530552, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3269964, 47.6045069 ], [ -122.327006, 47.604503 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530554, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3269883, 47.604509 ], [ -122.3269964, 47.6045069 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530556, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327141, 47.6046801 ], [ -122.3271552, 47.6046747 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530558, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3269628, 47.6047475 ], [ -122.3269445, 47.6047416 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530559, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326969, 47.6047364 ], [ -122.3269445, 47.6047416 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530560, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326969, 47.6047364 ], [ -122.3269628, 47.6047475 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530561, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3237097, 47.6059183 ], [ -122.323799, 47.606036 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530562, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3237665, 47.6060677 ], [ -122.323664, 47.6061146 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530563, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323627, 47.6061087 ], [ -122.3235199, 47.6060062 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530564, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235369, 47.605976 ], [ -122.3236461, 47.6059106 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530565, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3234561, 47.6059932 ], [ -122.3234629, 47.6059797 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530566, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235369, 47.605976 ], [ -122.3234629, 47.6059797 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530567, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235199, 47.6060062 ], [ -122.3234561, 47.6059932 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530568, "project_id": 13, "task_id": 401 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238162, 47.6060484 ], [ -122.3238328, 47.6060776 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530569, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3237665, 47.6060677 ], [ -122.3238328, 47.6060776 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530570, "project_id": 13, "task_id": 407 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323799, 47.606036 ], [ -122.3238162, 47.6060484 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530571, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236403, 47.6061431 ], [ -122.3236207, 47.606141 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530572, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323627, 47.6061087 ], [ -122.3236207, 47.606141 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530573, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323664, 47.6061146 ], [ -122.3236403, 47.6061431 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530574, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214443, 47.606872 ], [ -122.3215593, 47.6069691 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530575, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3215596, 47.607 ], [ -122.321446, 47.607049 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530576, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321446, 47.607049 ], [ -122.3213164, 47.6069099 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530577, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3213164, 47.6069099 ], [ -122.3214443, 47.606872 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530578, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3212772, 47.6069188 ], [ -122.3212582, 47.6068973 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530579, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3213164, 47.6069099 ], [ -122.3212582, 47.6068973 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530580, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3213164, 47.6069099 ], [ -122.3212772, 47.6069188 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530581, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214337, 47.6068263 ], [ -122.3214531, 47.6068469 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530582, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214443, 47.606872 ], [ -122.3214531, 47.6068469 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530583, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214443, 47.606872 ], [ -122.3214337, 47.6068263 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530584, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321599, 47.6069692 ], [ -122.3215687, 47.6069821 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530585, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3215596, 47.607 ], [ -122.3215687, 47.6069821 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530586, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3215593, 47.6069691 ], [ -122.321599, 47.6069692 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530587, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214137, 47.6070759 ], [ -122.3214047, 47.6070624 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530588, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321446, 47.607049 ], [ -122.3214047, 47.6070624 ] ] } }, +{ "type": "Feature", "properties": { "id": 1530589, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321446, 47.607049 ], [ -122.3214137, 47.6070759 ] ] } }, +{ "type": "Feature", "properties": { "id": 1531796, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140978, 47.609145 ], [ -122.3142201, 47.6091444 ] ] } }, +{ "type": "Feature", "properties": { "id": 1531797, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142733, 47.6091809 ], [ -122.3142786, 47.6092608 ] ] } }, +{ "type": "Feature", "properties": { "id": 1531798, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142275, 47.6092985 ], [ -122.3141025, 47.6092983 ] ] } }, +{ "type": "Feature", "properties": { "id": 1531799, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140483, 47.6092606 ], [ -122.3140474, 47.6091792 ] ] } }, +{ "type": "Feature", "properties": { "id": 1531800, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140464, 47.6093067 ], [ -122.3140265, 47.6092953 ] ] } }, +{ "type": "Feature", "properties": { "id": 1531801, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140483, 47.6092606 ], [ -122.3140265, 47.6092953 ] ] } }, +{ "type": "Feature", "properties": { "id": 1531802, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3141025, 47.6092983 ], [ -122.3140464, 47.6093067 ] ] } }, +{ "type": "Feature", "properties": { "id": 1531803, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140269, 47.6091486 ], [ -122.3140537, 47.6091288 ] ] } }, +{ "type": "Feature", "properties": { "id": 1531804, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140978, 47.609145 ], [ -122.3140537, 47.6091288 ] ] } }, +{ "type": "Feature", "properties": { "id": 1531805, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140474, 47.6091792 ], [ -122.3140269, 47.6091486 ] ] } }, +{ "type": "Feature", "properties": { "id": 1531806, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142733, 47.6091809 ], [ -122.3142892, 47.6091451 ] ] } }, +{ "type": "Feature", "properties": { "id": 1531807, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142201, 47.6091444 ], [ -122.3142711, 47.6091325 ] ] } }, +{ "type": "Feature", "properties": { "id": 1531808, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3143049, 47.609293 ], [ -122.3142737, 47.609313 ] ] } }, +{ "type": "Feature", "properties": { "id": 1531809, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142275, 47.6092985 ], [ -122.3142737, 47.609313 ] ] } }, +{ "type": "Feature", "properties": { "id": 1531810, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142786, 47.6092608 ], [ -122.3143049, 47.609293 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533707, "project_id": 14, "task_id": 214 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3143113, 47.6026447 ], [ -122.3143109, 47.6027361 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533708, "project_id": 14, "task_id": 214 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314269, 47.6027529 ], [ -122.3141395, 47.6027538 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533709, "project_id": 14, "task_id": 214 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3141082, 47.6027322 ], [ -122.3141062, 47.6026459 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533710, "project_id": 14, "task_id": 214 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3141332, 47.6026264 ], [ -122.3142847, 47.6026269 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533711, "project_id": 14, "task_id": 214 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140784, 47.6026262 ], [ -122.3140937, 47.6026137 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533712, "project_id": 14, "task_id": 214 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3141332, 47.6026264 ], [ -122.3140937, 47.6026137 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533713, "project_id": 14, "task_id": 214 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3141062, 47.6026459 ], [ -122.3140784, 47.6026262 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533714, "project_id": 14, "task_id": 214 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3143217, 47.6026177 ], [ -122.3143332, 47.6026274 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533715, "project_id": 14, "task_id": 214 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3143113, 47.6026447 ], [ -122.3143332, 47.6026274 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533716, "project_id": 14, "task_id": 214 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142847, 47.6026269 ], [ -122.3143217, 47.6026177 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533717, "project_id": 14, "task_id": 214 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140987, 47.6027647 ], [ -122.3140854, 47.6027498 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533718, "project_id": 14, "task_id": 214 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3141082, 47.6027322 ], [ -122.3140854, 47.6027498 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533719, "project_id": 14, "task_id": 214 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3141395, 47.6027538 ], [ -122.3140987, 47.6027647 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533720, "project_id": 14, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31413, 47.6034544 ], [ -122.3142614, 47.6034506 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533721, "project_id": 14, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314308, 47.6034692 ], [ -122.314316, 47.6035536 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533722, "project_id": 14, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314273, 47.6035794 ], [ -122.314135, 47.6035781 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533723, "project_id": 14, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314095, 47.6035527 ], [ -122.314099, 47.603477 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533724, "project_id": 14, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140936, 47.6035788 ], [ -122.3140928, 47.6035741 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533725, "project_id": 14, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314095, 47.6035527 ], [ -122.3140928, 47.6035741 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533726, "project_id": 14, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314135, 47.6035781 ], [ -122.3140936, 47.6035788 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533727, "project_id": 14, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314097, 47.6034595 ], [ -122.3140973, 47.6034546 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533728, "project_id": 14, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31413, 47.6034544 ], [ -122.3140973, 47.6034546 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533729, "project_id": 14, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314099, 47.603477 ], [ -122.314097, 47.6034595 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533730, "project_id": 14, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3143065, 47.6034491 ], [ -122.3143075, 47.6034562 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533731, "project_id": 14, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314308, 47.6034692 ], [ -122.3143075, 47.6034562 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533732, "project_id": 14, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142614, 47.6034506 ], [ -122.3143065, 47.6034491 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533733, "project_id": 14, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140677, 47.6061079 ], [ -122.3140764, 47.6061078 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533734, "project_id": 14, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140915, 47.6061083 ], [ -122.3140764, 47.6061078 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533735, "project_id": 14, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140685, 47.6061245 ], [ -122.3140677, 47.6061079 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533736, "project_id": 14, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314293, 47.6061063 ], [ -122.3142924, 47.6061134 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533737, "project_id": 14, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142928, 47.6061294 ], [ -122.3142924, 47.6061134 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533738, "project_id": 14, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142539, 47.6061049 ], [ -122.314293, 47.6061063 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533739, "project_id": 14, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142933, 47.6062858 ], [ -122.3142793, 47.6062891 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533740, "project_id": 14, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142632, 47.6062941 ], [ -122.3142793, 47.6062891 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533741, "project_id": 14, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142931, 47.6062706 ], [ -122.3142933, 47.6062858 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533742, "project_id": 14, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140649, 47.6062699 ], [ -122.3140664, 47.6062827 ] ] } }, +{ "type": "Feature", "properties": { "id": 1533743, "project_id": 14, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140995, 47.6062914 ], [ -122.3140661, 47.6062904 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534048, "project_id": 14, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088911, 47.601595 ], [ -122.309066, 47.6016024 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534049, "project_id": 14, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3091085, 47.60162 ], [ -122.309084, 47.6017479 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534050, "project_id": 14, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090548, 47.6017673 ], [ -122.3089098, 47.6017644 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534051, "project_id": 14, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.308865, 47.6017467 ], [ -122.3088596, 47.6016169 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534053, "project_id": 14, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.308865, 47.6017467 ], [ -122.3088647, 47.6017642 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534054, "project_id": 14, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3089098, 47.6017644 ], [ -122.3088647, 47.6017642 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534056, "project_id": 14, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088911, 47.601595 ], [ -122.3088609, 47.6015948 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534057, "project_id": 14, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088596, 47.6016169 ], [ -122.3088609, 47.6015948 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534059, "project_id": 14, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3091085, 47.60162 ], [ -122.3091076, 47.6016056 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534060, "project_id": 14, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.309066, 47.6016024 ], [ -122.3091076, 47.6016056 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534063, "project_id": 14, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.309084, 47.6017479 ], [ -122.3090848, 47.6017599 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534674, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223725, 47.5974085 ], [ -122.3223478, 47.5974078 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534675, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322307, 47.5974482 ], [ -122.3223072, 47.5974366 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534676, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223468, 47.5976157 ], [ -122.322347, 47.5975944 ], [ -122.322304, 47.5975938 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534677, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223037, 47.59758 ], [ -122.322304, 47.5975938 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534678, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322367, 47.597616 ], [ -122.3223468, 47.5976157 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534681, "project_id": 14, "task_id": 39 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3126347, 47.597522 ], [ -122.312564, 47.5974316 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534682, "project_id": 14, "task_id": 39 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31258, 47.5974113 ], [ -122.3128282, 47.597414 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534686, "project_id": 14, "task_id": 39 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3128453, 47.5974065 ], [ -122.312864, 47.5974148 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534687, "project_id": 14, "task_id": 39 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3128686, 47.5974306 ], [ -122.312864, 47.5974148 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534688, "project_id": 14, "task_id": 39 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3128282, 47.597414 ], [ -122.3128453, 47.5974065 ] ] } }, +{ "type": "Feature", "properties": { "id": 1534693, "project_id": 14, "task_id": 39 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3126347, 47.597522 ], [ -122.3126736, 47.5975726 ] ] } }, +{ "type": "Feature", "properties": { "id": 1537597, "project_id": 14, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.307537, 47.6062319 ], [ -122.3075375, 47.6061147 ] ] } }, +{ "type": "Feature", "properties": { "id": 1537598, "project_id": 14, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3075701, 47.6060874 ], [ -122.3077186, 47.60609 ] ] } }, +{ "type": "Feature", "properties": { "id": 1537599, "project_id": 14, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.307773, 47.60611 ], [ -122.307777, 47.6062295 ] ] } }, +{ "type": "Feature", "properties": { "id": 1537600, "project_id": 14, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077273, 47.6062594 ], [ -122.307586, 47.6062635 ] ] } }, +{ "type": "Feature", "properties": { "id": 1537602, "project_id": 14, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.307537, 47.6062319 ], [ -122.3075368, 47.6062642 ] ] } }, +{ "type": "Feature", "properties": { "id": 1537603, "project_id": 14, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.307586, 47.6062635 ], [ -122.3075368, 47.6062642 ] ] } }, +{ "type": "Feature", "properties": { "id": 1537605, "project_id": 14, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3075701, 47.6060874 ], [ -122.3075379, 47.6060815 ] ] } }, +{ "type": "Feature", "properties": { "id": 1537606, "project_id": 14, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3075375, 47.6061147 ], [ -122.3075379, 47.6060815 ] ] } }, +{ "type": "Feature", "properties": { "id": 1537608, "project_id": 14, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.307773, 47.60611 ], [ -122.307771, 47.6060875 ] ] } }, +{ "type": "Feature", "properties": { "id": 1537609, "project_id": 14, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077186, 47.60609 ], [ -122.307771, 47.6060875 ] ] } }, +{ "type": "Feature", "properties": { "id": 1537610, "project_id": 14, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077796, 47.6062607 ], [ -122.3077649, 47.6062606 ] ] } }, +{ "type": "Feature", "properties": { "id": 1537611, "project_id": 14, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077273, 47.6062594 ], [ -122.3077649, 47.6062606 ] ] } }, +{ "type": "Feature", "properties": { "id": 1537612, "project_id": 14, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.307777, 47.6062295 ], [ -122.3077796, 47.6062607 ] ] } }, +{ "type": "Feature", "properties": { "id": 1550530, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223462, 47.6046723 ], [ -122.3222518, 47.6045811 ] ] } }, +{ "type": "Feature", "properties": { "id": 1553355, "project_id": 14, "task_id": 46 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.309048, 47.6061148 ], [ -122.309054, 47.6062257 ] ] } }, +{ "type": "Feature", "properties": { "id": 1553356, "project_id": 14, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.309018, 47.606256 ], [ -122.308868, 47.6062523 ] ] } }, +{ "type": "Feature", "properties": { "id": 1553357, "project_id": 14, "task_id": 46 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.308835, 47.6062318 ], [ -122.30884, 47.6061116 ] ] } }, +{ "type": "Feature", "properties": { "id": 1553358, "project_id": 14, "task_id": 46 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.308876, 47.6060829 ], [ -122.3090133, 47.6060914 ] ] } }, +{ "type": "Feature", "properties": { "id": 1553359, "project_id": 14, "task_id": 46 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088413, 47.6060965 ], [ -122.3088413, 47.6060824 ] ] } }, +{ "type": "Feature", "properties": { "id": 1553360, "project_id": 14, "task_id": 46 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.308876, 47.6060829 ], [ -122.3088413, 47.6060824 ] ] } }, +{ "type": "Feature", "properties": { "id": 1553361, "project_id": 14, "task_id": 46 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.30884, 47.6061116 ], [ -122.3088413, 47.6060965 ] ] } }, +{ "type": "Feature", "properties": { "id": 1553363, "project_id": 14, "task_id": 46 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.309048, 47.6061148 ], [ -122.3090581, 47.6060867 ] ] } }, +{ "type": "Feature", "properties": { "id": 1553364, "project_id": 14, "task_id": 46 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090133, 47.6060914 ], [ -122.3090581, 47.6060867 ] ] } }, +{ "type": "Feature", "properties": { "id": 1678183, "project_id": 14, "task_id": 291 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3113753, 47.6027383 ], [ -122.311212, 47.6027437 ] ] } }, +{ "type": "Feature", "properties": { "id": 1678184, "project_id": 14, "task_id": 291 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311159, 47.602721 ], [ -122.3111564, 47.602649 ] ] } }, +{ "type": "Feature", "properties": { "id": 1678188, "project_id": 14, "task_id": 291 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3111564, 47.602649 ], [ -122.3111523, 47.6026238 ] ] } }, +{ "type": "Feature", "properties": { "id": 1678193, "project_id": 14, "task_id": 291 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311159, 47.602721 ], [ -122.3111579, 47.6027443 ] ] } }, +{ "type": "Feature", "properties": { "id": 1678194, "project_id": 14, "task_id": 291 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311212, 47.6027437 ], [ -122.3111579, 47.6027443 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680807, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194939, 47.6008404 ], [ -122.3195174, 47.6009146 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680808, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319482, 47.6009761 ], [ -122.319375, 47.6009927 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680809, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192734, 47.6009329 ], [ -122.3192518, 47.6008714 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680810, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193239, 47.6008295 ], [ -122.3194345, 47.6008125 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680811, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193239, 47.6008295 ], [ -122.3192419, 47.6008427 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680812, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192518, 47.6008714 ], [ -122.3192466, 47.6008559 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680813, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194758, 47.6008096 ], [ -122.3194826, 47.6008226 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680814, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194939, 47.6008404 ], [ -122.3194826, 47.6008226 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680815, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194345, 47.6008125 ], [ -122.3194758, 47.6008096 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680816, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195243, 47.600939 ], [ -122.3195318, 47.600968 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680817, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319482, 47.6009761 ], [ -122.3195318, 47.600968 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680818, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195174, 47.6009146 ], [ -122.3195243, 47.600939 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680819, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192943, 47.6010055 ], [ -122.3192781, 47.6009508 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680820, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192734, 47.6009329 ], [ -122.3192781, 47.6009508 ] ] } }, +{ "type": "Feature", "properties": { "id": 1680821, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319375, 47.6009927 ], [ -122.3192943, 47.6010055 ] ] } }, +{ "type": "Feature", "properties": { "id": 1693158, "project_id": 13, "task_id": 51 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320915, 47.6064196 ], [ -122.3209094, 47.6065185 ] ] } }, +{ "type": "Feature", "properties": { "id": 1693159, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208922, 47.6063017 ], [ -122.3208836, 47.6063629 ], [ -122.3208901, 47.6063864 ], [ -122.3209089, 47.6064069 ] ] } }, +{ "type": "Feature", "properties": { "id": 1693160, "project_id": 13, "task_id": 51 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320915, 47.6064196 ], [ -122.3209089, 47.6064069 ] ] } }, +{ "type": "Feature", "properties": { "id": 1693162, "project_id": 13, "task_id": 51 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209093, 47.6065418 ], [ -122.3208978, 47.606556 ] ] } }, +{ "type": "Feature", "properties": { "id": 1693164, "project_id": 13, "task_id": 51 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209094, 47.6065185 ], [ -122.3209093, 47.6065418 ] ] } }, +{ "type": "Feature", "properties": { "id": 1693165, "project_id": 13, "task_id": 51 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206314, 47.6065561 ], [ -122.3206333, 47.6063367 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700646, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3228846, 47.6033492 ], [ -122.3229447, 47.6034149 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700647, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3229272, 47.6034707 ], [ -122.322811, 47.6035177 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700648, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3227359, 47.6035041 ], [ -122.3226758, 47.6034372 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700649, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226987, 47.6033716 ], [ -122.3227896, 47.6033325 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700650, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226368, 47.6033999 ], [ -122.3226499, 47.6033946 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700651, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226987, 47.6033716 ], [ -122.3226499, 47.6033946 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700652, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226758, 47.6034372 ], [ -122.3226368, 47.6033999 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700654, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3228846, 47.6033492 ], [ -122.3228457, 47.6033089 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700655, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3227896, 47.6033325 ], [ -122.3228457, 47.6033089 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700656, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3229447, 47.6034149 ], [ -122.3229766, 47.6034515 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700657, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3229272, 47.6034707 ], [ -122.3229766, 47.6034515 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700659, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322769, 47.603535 ], [ -122.3227593, 47.6035274 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700660, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3227359, 47.6035041 ], [ -122.3227593, 47.6035274 ] ] } }, +{ "type": "Feature", "properties": { "id": 1700661, "project_id": 13, "task_id": 271 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322811, 47.6035177 ], [ -122.322769, 47.603535 ] ] } }, +{ "type": "Feature", "properties": { "id": 1740761, "project_id": 14, "task_id": 269 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209203, 47.6080707 ], [ -122.3209112, 47.6082094 ] ] } }, +{ "type": "Feature", "properties": { "id": 1747871, "project_id": 13, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3237589, 47.608011 ], [ -122.3236847, 47.6079247 ] ] } }, +{ "type": "Feature", "properties": { "id": 1747872, "project_id": 13, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3237185, 47.6078849 ], [ -122.3238905, 47.6078151 ] ] } }, +{ "type": "Feature", "properties": { "id": 1747873, "project_id": 13, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236727, 47.6079026 ], [ -122.3236938, 47.6078928 ] ] } }, +{ "type": "Feature", "properties": { "id": 1747874, "project_id": 13, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3237185, 47.6078849 ], [ -122.3236938, 47.6078928 ] ] } }, +{ "type": "Feature", "properties": { "id": 1747875, "project_id": 13, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236847, 47.6079247 ], [ -122.3236727, 47.6079026 ] ] } }, +{ "type": "Feature", "properties": { "id": 1747877, "project_id": 13, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3237589, 47.608011 ], [ -122.3237916, 47.6080268 ] ] } }, +{ "type": "Feature", "properties": { "id": 1749672, "project_id": 14, "task_id": 334 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153816, 47.6056053 ], [ -122.315377, 47.6055271 ] ] } }, +{ "type": "Feature", "properties": { "id": 1749673, "project_id": 14, "task_id": 334 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.315593, 47.6055293 ], [ -122.3155977, 47.6056088 ] ] } }, +{ "type": "Feature", "properties": { "id": 1749674, "project_id": 14, "task_id": 334 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153763, 47.6055165 ], [ -122.3155915, 47.6055167 ] ] } }, +{ "type": "Feature", "properties": { "id": 1749675, "project_id": 14, "task_id": 334 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.315593, 47.6055293 ], [ -122.3155915, 47.6055167 ] ] } }, +{ "type": "Feature", "properties": { "id": 1749676, "project_id": 14, "task_id": 334 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.315377, 47.6055271 ], [ -122.3153763, 47.6055165 ] ] } }, +{ "type": "Feature", "properties": { "id": 1749677, "project_id": 14, "task_id": 334 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155721, 47.6056211 ], [ -122.3154125, 47.6056212 ] ] } }, +{ "type": "Feature", "properties": { "id": 1749678, "project_id": 14, "task_id": 334 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153816, 47.6056053 ], [ -122.3153841, 47.6056263 ] ] } }, +{ "type": "Feature", "properties": { "id": 1749679, "project_id": 14, "task_id": 334 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155977, 47.6056088 ], [ -122.3155935, 47.6056198 ] ] } }, +{ "type": "Feature", "properties": { "id": 1762327, "project_id": 14, "task_id": 237 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3165277, 47.5999615 ], [ -122.3165356, 47.600083 ] ] } }, +{ "type": "Feature", "properties": { "id": 1762328, "project_id": 14, "task_id": 155 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3161779, 47.5999467 ], [ -122.3165259, 47.599945 ] ] } }, +{ "type": "Feature", "properties": { "id": 1762329, "project_id": 14, "task_id": 237 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3165277, 47.5999615 ], [ -122.3165259, 47.599945 ] ] } }, +{ "type": "Feature", "properties": { "id": 1762331, "project_id": 14, "task_id": 155 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3165355, 47.6000955 ], [ -122.316232, 47.6000973 ] ] } }, +{ "type": "Feature", "properties": { "id": 1762333, "project_id": 14, "task_id": 237 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3165356, 47.600083 ], [ -122.3165355, 47.6000955 ] ] } }, +{ "type": "Feature", "properties": { "id": 1776360, "project_id": 14, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103309, 47.6042941 ], [ -122.3103507, 47.6043855 ] ] } }, +{ "type": "Feature", "properties": { "id": 1776361, "project_id": 14, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101514, 47.6043895 ], [ -122.3101048, 47.6042988 ] ] } }, +{ "type": "Feature", "properties": { "id": 1776362, "project_id": 14, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101329, 47.604274 ], [ -122.3102816, 47.6042726 ] ] } }, +{ "type": "Feature", "properties": { "id": 1776364, "project_id": 14, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101329, 47.604274 ], [ -122.3100898, 47.6042718 ] ] } }, +{ "type": "Feature", "properties": { "id": 1776365, "project_id": 14, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101048, 47.6042988 ], [ -122.3100898, 47.6042718 ] ] } }, +{ "type": "Feature", "properties": { "id": 1776366, "project_id": 14, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103092, 47.6042659 ], [ -122.3103297, 47.6042757 ] ] } }, +{ "type": "Feature", "properties": { "id": 1776367, "project_id": 14, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103309, 47.6042941 ], [ -122.3103297, 47.6042757 ] ] } }, +{ "type": "Feature", "properties": { "id": 1776368, "project_id": 14, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3102816, 47.6042726 ], [ -122.3103092, 47.6042659 ] ] } }, +{ "type": "Feature", "properties": { "id": 1776369, "project_id": 14, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103289, 47.6044046 ], [ -122.3101943, 47.6044033 ] ] } }, +{ "type": "Feature", "properties": { "id": 1776370, "project_id": 14, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101514, 47.6043895 ], [ -122.3101469, 47.6044029 ] ] } }, +{ "type": "Feature", "properties": { "id": 1776371, "project_id": 14, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103507, 47.6043855 ], [ -122.310386, 47.6044051 ] ] } }, +{ "type": "Feature", "properties": { "id": 1777582, "project_id": 14, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140389, 47.6007805 ], [ -122.3142526, 47.6007749 ] ] } }, +{ "type": "Feature", "properties": { "id": 1777583, "project_id": 14, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142516, 47.60092 ], [ -122.3140431, 47.6009304 ] ] } }, +{ "type": "Feature", "properties": { "id": 1777584, "project_id": 14, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314013, 47.6009055 ], [ -122.3140193, 47.6008076 ] ] } }, +{ "type": "Feature", "properties": { "id": 1777585, "project_id": 14, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140071, 47.6009348 ], [ -122.3139967, 47.6009295 ] ] } }, +{ "type": "Feature", "properties": { "id": 1777586, "project_id": 14, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314013, 47.6009055 ], [ -122.3139967, 47.6009295 ] ] } }, +{ "type": "Feature", "properties": { "id": 1777587, "project_id": 14, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140431, 47.6009304 ], [ -122.3140071, 47.6009348 ] ] } }, +{ "type": "Feature", "properties": { "id": 1777588, "project_id": 14, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3139795, 47.6007744 ], [ -122.3140028, 47.600764 ] ] } }, +{ "type": "Feature", "properties": { "id": 1777589, "project_id": 14, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140389, 47.6007805 ], [ -122.3140028, 47.600764 ] ] } }, +{ "type": "Feature", "properties": { "id": 1777590, "project_id": 14, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140193, 47.6008076 ], [ -122.3139795, 47.6007744 ] ] } }, +{ "type": "Feature", "properties": { "id": 1777591, "project_id": 14, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142903, 47.600776 ], [ -122.3142893, 47.6009221 ] ] } }, +{ "type": "Feature", "properties": { "id": 1777592, "project_id": 14, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142516, 47.60092 ], [ -122.3142893, 47.6009221 ] ] } }, +{ "type": "Feature", "properties": { "id": 1777593, "project_id": 14, "task_id": 373 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142526, 47.6007749 ], [ -122.3142903, 47.600776 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779091, "project_id": 14, "task_id": 106 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3136431, 47.5988384 ], [ -122.3135812, 47.5987589 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779093, "project_id": 14, "task_id": 106 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3135694, 47.5987419 ], [ -122.313448, 47.5985826 ], [ -122.3133141, 47.5984098 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779094, "project_id": 14, "task_id": 183 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3136136, 47.5984146 ], [ -122.3133358, 47.598396 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779095, "project_id": 14, "task_id": 106 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3135812, 47.5987589 ], [ -122.3135694, 47.5987419 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779097, "project_id": 14, "task_id": 106 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3136431, 47.5988384 ], [ -122.3136489, 47.5988648 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779098, "project_id": 14, "task_id": 104 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3136299, 47.5984167 ], [ -122.314029, 47.5989537 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779581, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218195, 47.6039294 ], [ -122.3217102, 47.6039693 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779582, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3216599, 47.6039526 ], [ -122.3216157, 47.6038848 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779583, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3217699, 47.6038134 ], [ -122.3218367, 47.6038816 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779584, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3215905, 47.6038614 ], [ -122.3217482, 47.6037958 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779585, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3217699, 47.6038134 ], [ -122.3217482, 47.6037958 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779586, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3216157, 47.6038848 ], [ -122.3215905, 47.6038614 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779588, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218195, 47.6039294 ], [ -122.3218631, 47.6039167 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779589, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218367, 47.6038816 ], [ -122.321855, 47.6039077 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779590, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3216659, 47.6039882 ], [ -122.3216598, 47.6039843 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779591, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3216599, 47.6039526 ], [ -122.3216598, 47.6039843 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779592, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3217102, 47.6039693 ], [ -122.3216659, 47.6039882 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779594, "project_id": 14, "task_id": 376 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.315718, 47.6000236 ], [ -122.315795, 47.600079 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779596, "project_id": 14, "task_id": 376 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.315718, 47.6000236 ], [ -122.3157188, 47.6000023 ] ] } }, +{ "type": "Feature", "properties": { "id": 1779600, "project_id": 14, "task_id": 376 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.315795, 47.600079 ], [ -122.3157874, 47.6000943 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786049, "project_id": 14, "task_id": 175 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208924, 47.6092961 ], [ -122.3208946, 47.6092678 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786050, "project_id": 14, "task_id": 175 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208946, 47.6092678 ], [ -122.3206559, 47.6093274 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786051, "project_id": 14, "task_id": 175 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208963, 47.6091232 ], [ -122.3206588, 47.6091421 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786052, "project_id": 14, "task_id": 175 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208946, 47.6092678 ], [ -122.3208963, 47.6091232 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786053, "project_id": 14, "task_id": 175 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206256, 47.6092827 ], [ -122.3206172, 47.6092065 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786054, "project_id": 14, "task_id": 176 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206573, 47.6094858 ], [ -122.3206559, 47.6093274 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786055, "project_id": 14, "task_id": 175 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206256, 47.6092827 ], [ -122.3206281, 47.6093233 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786056, "project_id": 14, "task_id": 175 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206559, 47.6093274 ], [ -122.3206281, 47.6093233 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786057, "project_id": 14, "task_id": 175 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206281, 47.6093233 ], [ -122.3194578, 47.6093187 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786058, "project_id": 14, "task_id": 175 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206588, 47.6091421 ], [ -122.3206187, 47.6091423 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786059, "project_id": 14, "task_id": 175 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206187, 47.6091423 ], [ -122.3206195, 47.6090301 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786060, "project_id": 14, "task_id": 175 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206172, 47.6092065 ], [ -122.3206172, 47.6091662 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786061, "project_id": 14, "task_id": 175 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206172, 47.6091662 ], [ -122.3206187, 47.6091423 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786062, "project_id": 14, "task_id": 175 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206172, 47.6091662 ], [ -122.3195046, 47.6091671 ], [ -122.3195036, 47.6092044 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786063, "project_id": 14, "task_id": 176 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206867, 47.6100405 ], [ -122.3206573, 47.6094858 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786064, "project_id": 14, "task_id": 259 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3202051, 47.6073776 ], [ -122.3193231, 47.6077482 ], [ -122.3190184, 47.6078569 ], [ -122.3187277, 47.6079277 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786065, "project_id": 14, "task_id": 259 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193436, 47.6079216 ], [ -122.3193231, 47.6077482 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786066, "project_id": 14, "task_id": 259 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3187277, 47.6079277 ], [ -122.318568, 47.6079536 ], [ -122.3184085, 47.6079662 ], [ -122.3182556, 47.6079762 ], [ -122.317927, 47.6079762 ], [ -122.3174281, 47.6079734 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786067, "project_id": 14, "task_id": 173 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206195, 47.6090301 ], [ -122.3206205, 47.6086679 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786068, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195004, 47.6027567 ], [ -122.31951, 47.6029176 ], [ -122.319526, 47.6031162 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786069, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195588, 47.6027562 ], [ -122.3195004, 47.6027567 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786070, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195004, 47.6027567 ], [ -122.319426, 47.6027537 ], [ -122.3193283, 47.6027463 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786071, "project_id": 14, "task_id": 173 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206205, 47.6086679 ], [ -122.3206248, 47.6083204 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786072, "project_id": 14, "task_id": 269 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208842, 47.6082353 ], [ -122.3206577, 47.6081787 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786073, "project_id": 14, "task_id": 269 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206372, 47.6081007 ], [ -122.3206264, 47.6080077 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786074, "project_id": 14, "task_id": 269 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208904, 47.6080468 ], [ -122.3206512, 47.6079943 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786075, "project_id": 14, "task_id": 269 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3211351, 47.6081523 ], [ -122.3209085, 47.6082353 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786076, "project_id": 14, "task_id": 269 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209085, 47.6082353 ], [ -122.3208842, 47.6082353 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786077, "project_id": 14, "task_id": 269 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209085, 47.6082353 ], [ -122.3209112, 47.6082094 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786078, "project_id": 14, "task_id": 269 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206248, 47.6083204 ], [ -122.3206332, 47.6081718 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786079, "project_id": 14, "task_id": 269 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206577, 47.6081787 ], [ -122.3206332, 47.6081718 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786080, "project_id": 14, "task_id": 269 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206332, 47.6081718 ], [ -122.3206372, 47.6081007 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786081, "project_id": 14, "task_id": 269 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208904, 47.6080468 ], [ -122.3209203, 47.6080707 ], [ -122.320961, 47.608047 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786082, "project_id": 14, "task_id": 269 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206512, 47.6079943 ], [ -122.3206231, 47.6079883 ], [ -122.3206264, 47.6080077 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786083, "project_id": 14, "task_id": 269 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206231, 47.6079883 ], [ -122.3201539, 47.6079988 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786084, "project_id": 14, "task_id": 269 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206231, 47.6079883 ], [ -122.320622, 47.607971 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786085, "project_id": 14, "task_id": 174 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320622, 47.607971 ], [ -122.3206275, 47.6075598 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786086, "project_id": 14, "task_id": 174 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206275, 47.6075598 ], [ -122.3206167, 47.6074909 ], [ -122.3205746, 47.6074371 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786087, "project_id": 14, "task_id": 174 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3205746, 47.6074371 ], [ -122.320593, 47.6074222 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786088, "project_id": 14, "task_id": 174 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320593, 47.6074222 ], [ -122.3206043, 47.6073371 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786089, "project_id": 14, "task_id": 174 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3205352, 47.6071482 ], [ -122.3203286, 47.6071464 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786090, "project_id": 14, "task_id": 174 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206043, 47.6073371 ], [ -122.320632, 47.6071664 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786091, "project_id": 13, "task_id": 163 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320882, 47.607068 ], [ -122.320653, 47.6071259 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786092, "project_id": 14, "task_id": 180 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320927, 47.6072364 ], [ -122.32093, 47.6072626 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786093, "project_id": 13, "task_id": 163 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209239, 47.607089 ], [ -122.3209199, 47.607073 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786094, "project_id": 13, "task_id": 163 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209477, 47.6070615 ], [ -122.3209199, 47.607073 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786095, "project_id": 13, "task_id": 163 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209002, 47.6070431 ], [ -122.3209199, 47.607073 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786096, "project_id": 13, "task_id": 163 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209199, 47.607073 ], [ -122.320882, 47.607068 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786097, "project_id": 14, "task_id": 180 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320632, 47.6071664 ], [ -122.3206317, 47.6071446 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786098, "project_id": 14, "task_id": 180 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3205352, 47.6071482 ], [ -122.3206317, 47.6071446 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786099, "project_id": 14, "task_id": 180 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206317, 47.6071446 ], [ -122.3206317, 47.6071285 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786100, "project_id": 14, "task_id": 180 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320653, 47.6071259 ], [ -122.3206317, 47.6071285 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786101, "project_id": 14, "task_id": 180 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206317, 47.6071285 ], [ -122.3206282, 47.6070212 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786102, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320438, 47.6062917 ], [ -122.3197449, 47.6062927 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786103, "project_id": 14, "task_id": 389 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197449, 47.6062927 ], [ -122.3195195, 47.6062902 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786104, "project_id": 14, "task_id": 389 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195166, 47.6061532 ], [ -122.3195193, 47.6061403 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786105, "project_id": 14, "task_id": 389 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195193, 47.6061403 ], [ -122.319513, 47.6061405 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786106, "project_id": 14, "task_id": 453 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319513, 47.6061405 ], [ -122.3195049, 47.6057112 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786107, "project_id": 14, "task_id": 389 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193447, 47.6061405 ], [ -122.3193402, 47.6057132 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786108, "project_id": 14, "task_id": 325 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180067, 47.6071307 ], [ -122.3180125, 47.6063257 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786109, "project_id": 14, "task_id": 325 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180125, 47.6063257 ], [ -122.3180241, 47.6062931 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786110, "project_id": 14, "task_id": 325 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3183663, 47.6062861 ], [ -122.3183512, 47.6071404 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786111, "project_id": 13, "task_id": 2 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319333, 47.6052722 ], [ -122.3193402, 47.6057132 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786112, "project_id": 13, "task_id": 41 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197447, 47.6052765 ], [ -122.3194979, 47.6052714 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786113, "project_id": 13, "task_id": 41 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195049, 47.6057112 ], [ -122.3194994, 47.6054724 ], [ -122.3194979, 47.6052714 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786114, "project_id": 13, "task_id": 269 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197447, 47.6052765 ], [ -122.320427, 47.6052777 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786115, "project_id": 13, "task_id": 269 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320427, 47.6052777 ], [ -122.3206162, 47.6052754 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786116, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209159, 47.6048634 ], [ -122.3208949, 47.6048453 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786117, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209091, 47.6048715 ], [ -122.3208949, 47.6048453 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786118, "project_id": 13, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320438, 47.6062917 ], [ -122.3205982, 47.6062892 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786119, "project_id": 13, "task_id": 51 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206314, 47.6065561 ], [ -122.3206308, 47.6066361 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786120, "project_id": 13, "task_id": 163 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206308, 47.6066361 ], [ -122.3206282, 47.6070212 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786121, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3221564, 47.6075823 ], [ -122.3225844, 47.6073932 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786122, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265243, 47.6008043 ], [ -122.3265237, 47.6008244 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786123, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265155, 47.6009515 ], [ -122.32652, 47.6009305 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786124, "project_id": 13, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239767, 47.6082094 ], [ -122.3243282, 47.608597 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786125, "project_id": 13, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324529, 47.6085071 ], [ -122.3244904, 47.6084807 ], [ -122.3243309, 47.6083005 ], [ -122.3241437, 47.6081084 ], [ -122.3240023, 47.607948 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786126, "project_id": 13, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3237916, 47.6080268 ], [ -122.3239767, 47.6082094 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786127, "project_id": 13, "task_id": 291 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236938, 47.6078928 ], [ -122.323577, 47.60776 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786128, "project_id": 13, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238264, 47.6080186 ], [ -122.3237916, 47.6080268 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786129, "project_id": 13, "task_id": 292 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323577, 47.60776 ], [ -122.3232546, 47.6074041 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786130, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238905, 47.6078151 ], [ -122.3233567, 47.6072287 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786131, "project_id": 13, "task_id": 11 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225844, 47.6073932 ], [ -122.3230355, 47.607187 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786132, "project_id": 13, "task_id": 292 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3231375, 47.6073152 ], [ -122.323105, 47.607295 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786133, "project_id": 13, "task_id": 292 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3231375, 47.6073152 ], [ -122.323172, 47.6073045 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786134, "project_id": 13, "task_id": 292 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3231375, 47.6073152 ], [ -122.3231801, 47.6073279 ], [ -122.3232546, 47.6074041 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786135, "project_id": 13, "task_id": 292 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3230355, 47.607187 ], [ -122.323038, 47.6072137 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786136, "project_id": 13, "task_id": 292 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3230355, 47.607187 ], [ -122.323046, 47.6071691 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786137, "project_id": 13, "task_id": 292 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3230355, 47.607187 ], [ -122.3229395, 47.6070704 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786138, "project_id": 13, "task_id": 292 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323105, 47.607295 ], [ -122.323038, 47.6072137 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786139, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323172, 47.6073045 ], [ -122.323346, 47.6072359 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786140, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323046, 47.6071691 ], [ -122.3232028, 47.6070985 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786141, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3232541, 47.6071069 ], [ -122.3233465, 47.6072064 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786142, "project_id": 13, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240023, 47.607948 ], [ -122.3238264, 47.6080186 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786143, "project_id": 13, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240111, 47.6079369 ], [ -122.3240065, 47.6079189 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786144, "project_id": 13, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240065, 47.6079189 ], [ -122.3239305, 47.6078213 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786145, "project_id": 13, "task_id": 288 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239086, 47.6078052 ], [ -122.3238905, 47.6078151 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786146, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3232319, 47.6070979 ], [ -122.3230745, 47.606919 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786147, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323346, 47.6072359 ], [ -122.3233567, 47.6072287 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786148, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3233733, 47.6072235 ], [ -122.3233567, 47.6072287 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786149, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3233465, 47.6072064 ], [ -122.3233733, 47.6072235 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786150, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3232319, 47.6070979 ], [ -122.3232541, 47.6071069 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786151, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3232028, 47.6070985 ], [ -122.3232319, 47.6070979 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786152, "project_id": 13, "task_id": 290 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3232319, 47.6070979 ], [ -122.32415, 47.6067105 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786153, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3229395, 47.6070704 ], [ -122.3225662, 47.6066617 ], [ -122.3225195, 47.6066356 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786154, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3230745, 47.606919 ], [ -122.3227516, 47.6065388 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786155, "project_id": 13, "task_id": 162 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3213028, 47.606674 ], [ -122.3214369, 47.606615 ], [ -122.3214532, 47.6065795 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786156, "project_id": 13, "task_id": 158 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214337, 47.6068263 ], [ -122.3213801, 47.6067678 ], [ -122.3213028, 47.606674 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786157, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225195, 47.6066356 ], [ -122.322474, 47.6066287 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786158, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225282, 47.6066218 ], [ -122.3225195, 47.6066356 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786159, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3227562, 47.6065115 ], [ -122.3227516, 47.6065388 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786160, "project_id": 13, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3227516, 47.6065388 ], [ -122.322728, 47.6065355 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786161, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249685, 47.6075403 ], [ -122.3249231, 47.6075582 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786162, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249231, 47.6075582 ], [ -122.3248962, 47.6075322 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786163, "project_id": 13, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249388, 47.6075707 ], [ -122.3249231, 47.6075582 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786167, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218037, 47.6058731 ], [ -122.3217185, 47.6057896 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786168, "project_id": 13, "task_id": 150 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219523, 47.6056619 ], [ -122.3221384, 47.6055839 ], [ -122.3226944, 47.605345 ], [ -122.3228342, 47.6052931 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786174, "project_id": 13, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3259077, 47.6069661 ], [ -122.3258045, 47.6068479 ], [ -122.3256689, 47.6066888 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786175, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3243377, 47.6066339 ], [ -122.3252312, 47.6062623 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786191, "project_id": 14, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166379, 47.6027519 ], [ -122.3160895, 47.6027527 ], [ -122.3155383, 47.6027536 ], [ -122.3150196, 47.6027511 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786192, "project_id": 14, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3150234, 47.6026251 ], [ -122.3153894, 47.6026276 ], [ -122.3159285, 47.6026314 ], [ -122.3162175, 47.6026341 ], [ -122.3166441, 47.6026395 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786193, "project_id": 14, "task_id": 230 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.315019, 47.6027294 ], [ -122.3150196, 47.6027511 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786195, "project_id": 14, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316649, 47.6026503 ], [ -122.3166441, 47.6026395 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786196, "project_id": 14, "task_id": 138 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3174723, 47.610464 ], [ -122.3173418, 47.6104642 ], [ -122.3173293, 47.6104799 ], [ -122.3172447, 47.6104805 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786197, "project_id": 14, "task_id": 138 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317471, 47.6103281 ], [ -122.3172246, 47.6103278 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786198, "project_id": 14, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3172447, 47.6104805 ], [ -122.3171789, 47.6104812 ], [ -122.3169392, 47.6104822 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786199, "project_id": 14, "task_id": 58 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3172246, 47.6103278 ], [ -122.3169614, 47.6103257 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786200, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3256689, 47.6066888 ], [ -122.3253958, 47.6063898 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786201, "project_id": 13, "task_id": 145 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252449, 47.6062335 ], [ -122.3250138, 47.6059756 ], [ -122.3247469, 47.6056844 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786202, "project_id": 14, "task_id": 136 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103243, 47.6081293 ], [ -122.3102765, 47.6087568 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786203, "project_id": 14, "task_id": 136 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101416, 47.6081282 ], [ -122.3101363, 47.6086835 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786204, "project_id": 14, "task_id": 58 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169392, 47.6104822 ], [ -122.31695, 47.6104555 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786206, "project_id": 14, "task_id": 58 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169614, 47.6103257 ], [ -122.3169505, 47.6103402 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786207, "project_id": 14, "task_id": 58 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169614, 47.6103257 ], [ -122.3169283, 47.6103251 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786208, "project_id": 14, "task_id": 58 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169283, 47.6103251 ], [ -122.3169006, 47.6103094 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786209, "project_id": 14, "task_id": 58 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169283, 47.6103251 ], [ -122.3169308, 47.6099778 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786210, "project_id": 14, "task_id": 58 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166739, 47.6104635 ], [ -122.3166441, 47.6104542 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786211, "project_id": 14, "task_id": 58 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166655, 47.6103137 ], [ -122.3166421, 47.6103369 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786212, "project_id": 14, "task_id": 58 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166655, 47.6103137 ], [ -122.3166927, 47.6103086 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786213, "project_id": 14, "task_id": 58 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169006, 47.6103094 ], [ -122.3166927, 47.6103086 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786214, "project_id": 14, "task_id": 58 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31695, 47.6104555 ], [ -122.3169505, 47.6103402 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786215, "project_id": 14, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3121972, 47.6044121 ], [ -122.3125812, 47.6044144 ], [ -122.3127838, 47.6044148 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786216, "project_id": 14, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127838, 47.6044148 ], [ -122.3128253, 47.6044153 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786217, "project_id": 14, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3121995, 47.604282 ], [ -122.3126449, 47.6042836 ], [ -122.3127785, 47.6042851 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786218, "project_id": 14, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127785, 47.6042851 ], [ -122.3128171, 47.6042851 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786219, "project_id": 14, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127785, 47.6042851 ], [ -122.3127774, 47.6042398 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786220, "project_id": 14, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127795, 47.6043094 ], [ -122.3127825, 47.6043838 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786221, "project_id": 14, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127838, 47.6044148 ], [ -122.3127818, 47.6044799 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786222, "project_id": 14, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127785, 47.6042851 ], [ -122.3127795, 47.6043094 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786223, "project_id": 14, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127825, 47.6043838 ], [ -122.3127838, 47.6044148 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786224, "project_id": 14, "task_id": 208 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169308, 47.6099778 ], [ -122.3169439, 47.6093673 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786225, "project_id": 14, "task_id": 206 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3178918, 47.6093341 ], [ -122.3169452, 47.6093182 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786226, "project_id": 14, "task_id": 206 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3179058, 47.6091718 ], [ -122.3169378, 47.6091604 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786227, "project_id": 14, "task_id": 206 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169377, 47.6089685 ], [ -122.3169381, 47.6091368 ], [ -122.3169378, 47.6091604 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786228, "project_id": 14, "task_id": 206 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169452, 47.6093182 ], [ -122.3169408, 47.6092708 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786229, "project_id": 14, "task_id": 206 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169452, 47.6093182 ], [ -122.3168905, 47.6093048 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786230, "project_id": 14, "task_id": 206 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169452, 47.6093182 ], [ -122.3169439, 47.6093673 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786231, "project_id": 14, "task_id": 206 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169378, 47.6091604 ], [ -122.316935, 47.6091821 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786232, "project_id": 14, "task_id": 206 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169378, 47.6091604 ], [ -122.3168885, 47.6091238 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786233, "project_id": 14, "task_id": 206 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166964, 47.6093279 ], [ -122.3166636, 47.609319 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786234, "project_id": 14, "task_id": 206 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166358, 47.6093063 ], [ -122.3166636, 47.609319 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786235, "project_id": 14, "task_id": 206 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166636, 47.609319 ], [ -122.3166548, 47.6092943 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786236, "project_id": 14, "task_id": 206 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166668, 47.6091265 ], [ -122.3167127, 47.6090981 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786237, "project_id": 14, "task_id": 206 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166668, 47.6091265 ], [ -122.3166247, 47.6091577 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786238, "project_id": 14, "task_id": 206 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3168885, 47.6091238 ], [ -122.3167127, 47.6090981 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786239, "project_id": 14, "task_id": 206 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316935, 47.6091821 ], [ -122.3169408, 47.6092708 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786240, "project_id": 14, "task_id": 206 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3168905, 47.6093048 ], [ -122.3166964, 47.6093279 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786241, "project_id": 14, "task_id": 206 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166247, 47.6091577 ], [ -122.3166449, 47.6091693 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786242, "project_id": 14, "task_id": 218 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169377, 47.6089685 ], [ -122.3169359, 47.6085814 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786243, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320892, 47.6018026 ], [ -122.3208983, 47.6022059 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786244, "project_id": 14, "task_id": 299 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169359, 47.6085814 ], [ -122.3169365, 47.6082993 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786245, "project_id": 14, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116832, 47.6044121 ], [ -122.3121972, 47.6044121 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786246, "project_id": 14, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311684, 47.6042782 ], [ -122.3121995, 47.604282 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786247, "project_id": 14, "task_id": 287 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116104, 47.6042788 ], [ -122.3116098, 47.6043105 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786248, "project_id": 14, "task_id": 287 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116104, 47.6042788 ], [ -122.311684, 47.6042782 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786249, "project_id": 14, "task_id": 287 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114793, 47.6044066 ], [ -122.3114126, 47.6044074 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786250, "project_id": 14, "task_id": 287 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114768, 47.6043116 ], [ -122.3114759, 47.6042799 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786251, "project_id": 14, "task_id": 297 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169365, 47.6082993 ], [ -122.3169356, 47.6081568 ], [ -122.316922, 47.6081251 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786252, "project_id": 14, "task_id": 342 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3186006, 47.6022884 ], [ -122.3184688, 47.6021655 ], [ -122.3183641, 47.6020686 ], [ -122.3182732, 47.6019777 ], [ -122.3182188, 47.6018985 ], [ -122.3182102, 47.6018759 ], [ -122.3182174, 47.6018396 ], [ -122.3182253, 47.6018018 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786253, "project_id": 14, "task_id": 445 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3181939, 47.6017994 ], [ -122.3181165, 47.6017889 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786254, "project_id": 14, "task_id": 445 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182253, 47.6018018 ], [ -122.3182316, 47.6017772 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786255, "project_id": 14, "task_id": 343 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3179928, 47.6016383 ], [ -122.3180388, 47.6016967 ], [ -122.3180921, 47.6017644 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786256, "project_id": 14, "task_id": 342 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3181165, 47.6017889 ], [ -122.3180665, 47.6017795 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786257, "project_id": 14, "task_id": 445 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180921, 47.6017644 ], [ -122.3181165, 47.6017889 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786258, "project_id": 14, "task_id": 234 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3177835, 47.6017789 ], [ -122.3177555, 47.6017791 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786259, "project_id": 14, "task_id": 445 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182253, 47.6018018 ], [ -122.3181939, 47.6017994 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786260, "project_id": 14, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114126, 47.6044074 ], [ -122.3107627, 47.6044055 ], [ -122.3105588, 47.604405 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786261, "project_id": 14, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103297, 47.6042757 ], [ -122.3107526, 47.6042758 ], [ -122.3111533, 47.6042782 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786262, "project_id": 14, "task_id": 366 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3113759, 47.6042788 ], [ -122.3113803, 47.6039424 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786263, "project_id": 14, "task_id": 366 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3111533, 47.6042782 ], [ -122.3111519, 47.6039337 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786264, "project_id": 14, "task_id": 366 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3111532, 47.6043093 ], [ -122.3111533, 47.6042782 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786265, "project_id": 14, "task_id": 366 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3111533, 47.6042782 ], [ -122.3113759, 47.6042788 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786266, "project_id": 14, "task_id": 366 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3113759, 47.6042788 ], [ -122.3114164, 47.604279 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786267, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236922, 47.6058913 ], [ -122.3237097, 47.6059183 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786268, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236686, 47.6058924 ], [ -122.3236461, 47.6059106 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786269, "project_id": 14, "task_id": 230 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3150234, 47.6026251 ], [ -122.3150111, 47.602635 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786270, "project_id": 14, "task_id": 230 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3148898, 47.6026334 ], [ -122.3148811, 47.6026277 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786271, "project_id": 14, "task_id": 230 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3150234, 47.6026251 ], [ -122.3150111, 47.602635 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786273, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194777, 47.6017869 ], [ -122.3194692, 47.6019906 ], [ -122.3194458, 47.602079 ], [ -122.3194163, 47.6021188 ], [ -122.3193594, 47.6021729 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786274, "project_id": 14, "task_id": 298 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3174281, 47.6079734 ], [ -122.3169211, 47.6079673 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786275, "project_id": 13, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3205895, 47.6026468 ], [ -122.320407, 47.6026382 ], [ -122.3197517, 47.6026444 ], [ -122.3195586, 47.6026425 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786276, "project_id": 13, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3200397, 47.6029378 ], [ -122.3198014, 47.6029396 ], [ -122.3197873, 47.6029486 ], [ -122.3197847, 47.6029699 ], [ -122.3197824, 47.6030882 ], [ -122.3197717, 47.6030913 ], [ -122.3197453, 47.6030913 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786277, "project_id": 13, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3200405, 47.6031115 ], [ -122.3195946, 47.6031126 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786278, "project_id": 13, "task_id": 404 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236686, 47.6058924 ], [ -122.3236922, 47.6058913 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786279, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236922, 47.6058913 ], [ -122.3239818, 47.6057766 ], [ -122.32454, 47.6055552 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786280, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3228703, 47.6053088 ], [ -122.3228342, 47.6052931 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786281, "project_id": 13, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3228887, 47.6052643 ], [ -122.3228378, 47.6052795 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786282, "project_id": 14, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101469, 47.6044029 ], [ -122.3101611, 47.6044675 ], [ -122.3101596, 47.6052679 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786283, "project_id": 14, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310301, 47.6041583 ], [ -122.3103047, 47.6039322 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786284, "project_id": 14, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3100898, 47.6042718 ], [ -122.3100772, 47.6041106 ], [ -122.3100821, 47.6039305 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786286, "project_id": 14, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103092, 47.6042659 ], [ -122.310301, 47.6041583 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786287, "project_id": 14, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3105588, 47.604405 ], [ -122.310386, 47.6044051 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786288, "project_id": 14, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310386, 47.6044051 ], [ -122.3103289, 47.6044046 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786289, "project_id": 14, "task_id": 222 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101943, 47.6044033 ], [ -122.3101469, 47.6044029 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786290, "project_id": 14, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101469, 47.6044029 ], [ -122.3096185, 47.604402 ], [ -122.3095332, 47.604402 ], [ -122.3090849, 47.6044014 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786291, "project_id": 14, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3100898, 47.6042718 ], [ -122.309082, 47.6042712 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786292, "project_id": 14, "task_id": 214 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3143109, 47.6027361 ], [ -122.3143233, 47.6027518 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786293, "project_id": 14, "task_id": 214 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314269, 47.6027529 ], [ -122.3142902, 47.6027675 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786294, "project_id": 14, "task_id": 214 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140854, 47.6027498 ], [ -122.3135724, 47.6027508 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786295, "project_id": 14, "task_id": 214 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140784, 47.6026262 ], [ -122.3135729, 47.6026252 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786296, "project_id": 14, "task_id": 214 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142902, 47.6027675 ], [ -122.3143233, 47.6027518 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786311, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192781, 47.6009508 ], [ -122.3191208, 47.6009716 ], [ -122.3191061, 47.6009826 ], [ -122.3190048, 47.6009878 ], [ -122.3189783, 47.6009779 ], [ -122.3188233, 47.6009838 ], [ -122.3187478, 47.6009838 ], [ -122.3187016, 47.60098 ], [ -122.318625, 47.6009673 ], [ -122.318582, 47.6009583 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786312, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192518, 47.6008714 ], [ -122.3191783, 47.6008824 ], [ -122.3191038, 47.6008917 ], [ -122.3190544, 47.6008967 ], [ -122.3189979, 47.6008996 ], [ -122.3187821, 47.6009052 ], [ -122.3187297, 47.6009018 ], [ -122.3186787, 47.6008941 ], [ -122.318641, 47.6008864 ], [ -122.318573, 47.6008641 ], [ -122.3185105, 47.60084 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786313, "project_id": 13, "task_id": 139 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180691, 47.6015674 ], [ -122.3181307, 47.6015677 ], [ -122.3181305, 47.6015535 ], [ -122.3184174, 47.6015551 ], [ -122.31844, 47.6015611 ], [ -122.318921, 47.6015612 ], [ -122.3194359, 47.6015634 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786314, "project_id": 14, "task_id": 343 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3179915, 47.601621 ], [ -122.3179928, 47.6016383 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786315, "project_id": 14, "task_id": 343 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3179915, 47.601621 ], [ -122.3180217, 47.6016199 ], [ -122.3180369, 47.6016033 ], [ -122.3180691, 47.6015674 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786316, "project_id": 14, "task_id": 234 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180691, 47.6015674 ], [ -122.3180365, 47.601568 ], [ -122.3179842, 47.6015751 ], [ -122.3179445, 47.6015845 ], [ -122.3179054, 47.601603 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786317, "project_id": 14, "task_id": 234 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317888, 47.6016119 ], [ -122.3179054, 47.601603 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786318, "project_id": 14, "task_id": 301 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169236, 47.607504 ], [ -122.3168937, 47.6075043 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786319, "project_id": 14, "task_id": 301 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166375, 47.6075039 ], [ -122.3166782, 47.6075047 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786320, "project_id": 14, "task_id": 301 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3168937, 47.6075043 ], [ -122.3166782, 47.6075047 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786321, "project_id": 14, "task_id": 367 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127814, 47.6026279 ], [ -122.3126751, 47.6026263 ], [ -122.3122021, 47.6026251 ], [ -122.3117018, 47.6026259 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786322, "project_id": 14, "task_id": 367 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127758, 47.6027472 ], [ -122.3122028, 47.6027421 ], [ -122.3116907, 47.602744 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786323, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3245623, 47.6055161 ], [ -122.3243341, 47.6052764 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786324, "project_id": 13, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3247811, 47.6054292 ], [ -122.3244941, 47.6051209 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786325, "project_id": 14, "task_id": 114 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155596, 47.6102926 ], [ -122.3155643, 47.6097531 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786326, "project_id": 14, "task_id": 114 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314911, 47.6103271 ], [ -122.3152835, 47.6103289 ], [ -122.3153534, 47.6103009 ], [ -122.3153616, 47.6097472 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786327, "project_id": 14, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101614, 47.6062766 ], [ -122.3099203, 47.6062758 ], [ -122.3092927, 47.6062739 ], [ -122.3090626, 47.6062709 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786328, "project_id": 14, "task_id": 46 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310151, 47.6060859 ], [ -122.3099219, 47.6060861 ], [ -122.3092865, 47.6060865 ], [ -122.3090581, 47.6060867 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786329, "project_id": 14, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090626, 47.6062709 ], [ -122.309018, 47.606256 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786330, "project_id": 14, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.309054, 47.6062257 ], [ -122.309018, 47.606256 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786331, "project_id": 14, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.308868, 47.6062523 ], [ -122.3088385, 47.606266 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786332, "project_id": 14, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.308835, 47.6062318 ], [ -122.308868, 47.6062523 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786333, "project_id": 14, "task_id": 113 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155643, 47.6097531 ], [ -122.3155735, 47.6093113 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786334, "project_id": 14, "task_id": 113 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153616, 47.6097472 ], [ -122.3153618, 47.6093135 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786335, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223293, 47.6017849 ], [ -122.322316, 47.6017533 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786336, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223293, 47.6017849 ], [ -122.3223705, 47.6017859 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786337, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223705, 47.6017859 ], [ -122.3225681, 47.6017856 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786338, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226405, 47.6017886 ], [ -122.3229694, 47.6017912 ], [ -122.3232573, 47.6017916 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786339, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225927, 47.601787 ], [ -122.3226405, 47.6017886 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786340, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226405, 47.6017886 ], [ -122.3226398, 47.6017686 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786341, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226398, 47.6017686 ], [ -122.3226385, 47.6016035 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786342, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322316, 47.6016028 ], [ -122.3223176, 47.6015779 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786343, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223176, 47.6015779 ], [ -122.3223898, 47.6015819 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786344, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223898, 47.6015819 ], [ -122.3225739, 47.601585 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786345, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226369, 47.6015852 ], [ -122.3231219, 47.6015859 ], [ -122.3232581, 47.6016002 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786346, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225739, 47.601585 ], [ -122.3226369, 47.6015852 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786347, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226369, 47.6015852 ], [ -122.3226385, 47.6016035 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786348, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225681, 47.6017856 ], [ -122.3225927, 47.601787 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786349, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225927, 47.601787 ], [ -122.3226061, 47.6019484 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786350, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223176, 47.6015779 ], [ -122.3223173, 47.6015417 ], [ -122.3223034, 47.6015272 ], [ -122.3222564, 47.601509 ], [ -122.3221909, 47.6014866 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786351, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3221909, 47.6014866 ], [ -122.3221059, 47.6014715 ], [ -122.3220167, 47.6014602 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786352, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3221909, 47.6014866 ], [ -122.3221575, 47.6014498 ], [ -122.3221347, 47.601419 ], [ -122.3221179, 47.6013788 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786353, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3221179, 47.6013788 ], [ -122.3221099, 47.6013281 ], [ -122.3220918, 47.601296 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786354, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3221179, 47.6013788 ], [ -122.3220764, 47.6014118 ], [ -122.3220154, 47.6014494 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786355, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3258692, 47.6049876 ], [ -122.3258866, 47.6049807 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786356, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3258609, 47.605001 ], [ -122.3258692, 47.6049876 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786357, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3257274, 47.6050511 ], [ -122.3257445, 47.6050492 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786358, "project_id": 13, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3257159, 47.6050568 ], [ -122.3257274, 47.6050511 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786359, "project_id": 14, "task_id": 403 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127769, 47.6027226 ], [ -122.3127758, 47.6027472 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786360, "project_id": 14, "task_id": 403 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127769, 47.6027226 ], [ -122.3127801, 47.6026457 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786361, "project_id": 14, "task_id": 403 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127801, 47.6026457 ], [ -122.3127814, 47.6026279 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786362, "project_id": 14, "task_id": 293 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127814, 47.6026279 ], [ -122.3127811, 47.6026114 ], [ -122.3127795, 47.6022242 ], [ -122.3127783, 47.6017748 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786363, "project_id": 14, "task_id": 293 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129903, 47.6017793 ], [ -122.3129924, 47.602041 ], [ -122.3129865, 47.6023224 ], [ -122.3129849, 47.602496 ], [ -122.312989, 47.6026253 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786364, "project_id": 14, "task_id": 402 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129913, 47.6026471 ], [ -122.3129982, 47.6027338 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786365, "project_id": 14, "task_id": 295 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129994, 47.6027489 ], [ -122.3129994, 47.6030139 ], [ -122.3129983, 47.6031174 ], [ -122.3129962, 47.6034523 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786366, "project_id": 14, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127758, 47.6027472 ], [ -122.3127776, 47.6029765 ], [ -122.3127765, 47.6031086 ], [ -122.3127756, 47.6034586 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786367, "project_id": 14, "task_id": 402 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3135724, 47.6027508 ], [ -122.3131877, 47.6027487 ], [ -122.3129994, 47.6027489 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786368, "project_id": 14, "task_id": 402 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3135729, 47.6026252 ], [ -122.312989, 47.6026253 ], [ -122.3129651, 47.6026256 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786369, "project_id": 14, "task_id": 402 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129557, 47.6027428 ], [ -122.3128261, 47.6027436 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786370, "project_id": 14, "task_id": 403 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3128261, 47.6027436 ], [ -122.3127758, 47.6027472 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786371, "project_id": 14, "task_id": 402 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129994, 47.6027489 ], [ -122.3129557, 47.6027428 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786372, "project_id": 14, "task_id": 402 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.312989, 47.6026253 ], [ -122.3129913, 47.6026471 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786373, "project_id": 14, "task_id": 402 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129982, 47.6027338 ], [ -122.3129994, 47.6027489 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786374, "project_id": 14, "task_id": 402 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129651, 47.6026256 ], [ -122.3128187, 47.602628 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786375, "project_id": 14, "task_id": 403 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3128187, 47.602628 ], [ -122.3127814, 47.6026279 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786376, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142711, 47.6091325 ], [ -122.3142833, 47.6081395 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786377, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140265, 47.6092953 ], [ -122.3116592, 47.6092849 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786378, "project_id": 14, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127508, 47.6091415 ], [ -122.3116702, 47.609134 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786379, "project_id": 13, "task_id": 361 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3232581, 47.6016002 ], [ -122.3238414, 47.6016378 ], [ -122.3240119, 47.6016402 ], [ -122.3248717, 47.6016431 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786380, "project_id": 13, "task_id": 361 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236832, 47.6017867 ], [ -122.3239937, 47.6017868 ], [ -122.3248696, 47.6017844 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786383, "project_id": 14, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310151, 47.6060859 ], [ -122.3101596, 47.6052679 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786384, "project_id": 14, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103591, 47.6062786 ], [ -122.3103116, 47.6062781 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786385, "project_id": 14, "task_id": 131 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3102083, 47.6062771 ], [ -122.3101614, 47.6062766 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786386, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192943, 47.6010055 ], [ -122.3193142, 47.6010711 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786387, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195395, 47.6009964 ], [ -122.3195318, 47.600968 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786388, "project_id": 14, "task_id": 414 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.318582, 47.6009583 ], [ -122.3185553, 47.6009502 ], [ -122.3184819, 47.6009229 ], [ -122.3184376, 47.6009081 ], [ -122.318421, 47.6008938 ], [ -122.3183879, 47.6008865 ], [ -122.3181798, 47.6008612 ], [ -122.318078, 47.6008491 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786389, "project_id": 14, "task_id": 413 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3185105, 47.60084 ], [ -122.3184456, 47.6008237 ], [ -122.3183711, 47.6008062 ], [ -122.3183119, 47.600795 ], [ -122.3182541, 47.6007858 ], [ -122.3182029, 47.6007791 ], [ -122.3181394, 47.6007736 ], [ -122.3180638, 47.6007697 ], [ -122.3176379, 47.6007676 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786390, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192419, 47.6008427 ], [ -122.3192034, 47.6007298 ], [ -122.3191638, 47.6006065 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786391, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195318, 47.600968 ], [ -122.3196778, 47.6009482 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786392, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3194758, 47.6008096 ], [ -122.3196235, 47.6007865 ], [ -122.3196978, 47.6007772 ], [ -122.3197767, 47.600772 ], [ -122.3198565, 47.6007707 ], [ -122.3199945, 47.600772 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786393, "project_id": 13, "task_id": 48 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193837, 47.6005285 ], [ -122.3194758, 47.6008096 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786394, "project_id": 13, "task_id": 361 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3248696, 47.6017844 ], [ -122.326032, 47.6017882 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786395, "project_id": 13, "task_id": 361 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3248717, 47.6016431 ], [ -122.3260345, 47.6016413 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786396, "project_id": 13, "task_id": 361 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3255878, 47.6009413 ], [ -122.3251519, 47.6009389 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786397, "project_id": 13, "task_id": 6 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3191638, 47.6006065 ], [ -122.3190495, 47.600256 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786398, "project_id": 13, "task_id": 5 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192596, 47.6001863 ], [ -122.319279, 47.6002147 ], [ -122.3192918, 47.6002463 ], [ -122.3193837, 47.6005285 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786399, "project_id": 13, "task_id": 5 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197797, 47.6001479 ], [ -122.3195701, 47.6001473 ], [ -122.3195191, 47.6001493 ], [ -122.3194621, 47.6001563 ], [ -122.3192596, 47.6001863 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786400, "project_id": 13, "task_id": 6 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3192029, 47.600146 ], [ -122.3192342, 47.6001642 ], [ -122.3192596, 47.6001863 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786401, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129653, 47.608521 ], [ -122.3129581, 47.6088835 ], [ -122.3129435, 47.6091437 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786402, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127605, 47.6085185 ], [ -122.3127508, 47.6091415 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786403, "project_id": 14, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116683, 47.6062856 ], [ -122.3127711, 47.6062868 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786404, "project_id": 14, "task_id": 133 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31167, 47.6060957 ], [ -122.3127675, 47.6060976 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786405, "project_id": 14, "task_id": 410 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173465, 47.5999751 ], [ -122.3178228, 47.5999797 ], [ -122.3182961, 47.5999813 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786406, "project_id": 13, "task_id": 6 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3190495, 47.600256 ], [ -122.3184541, 47.6001199 ], [ -122.3183625, 47.6001041 ], [ -122.3181915, 47.600104 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786407, "project_id": 13, "task_id": 6 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3190935, 47.6002453 ], [ -122.3191723, 47.6001709 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786408, "project_id": 13, "task_id": 6 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3191723, 47.6001709 ], [ -122.3192029, 47.600146 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786409, "project_id": 13, "task_id": 6 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3190495, 47.600256 ], [ -122.3190935, 47.6002453 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786410, "project_id": 14, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116567, 47.6091207 ], [ -122.3116705, 47.6081262 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786411, "project_id": 14, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311646, 47.6092955 ], [ -122.3116497, 47.6094846 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786412, "project_id": 14, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116592, 47.6092849 ], [ -122.3116305, 47.6092546 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786413, "project_id": 14, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311646, 47.6092955 ], [ -122.311605, 47.6092867 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786414, "project_id": 14, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116702, 47.609134 ], [ -122.3116307, 47.6091742 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786415, "project_id": 14, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116567, 47.6091207 ], [ -122.311601, 47.6091461 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786416, "project_id": 14, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116307, 47.6091742 ], [ -122.3116305, 47.6092546 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786417, "project_id": 14, "task_id": 93 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077863, 47.6030831 ], [ -122.307786, 47.6031807 ], [ -122.3077883, 47.6034581 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786418, "project_id": 14, "task_id": 93 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3075607, 47.6030891 ], [ -122.3075609, 47.6033753 ], [ -122.3075596, 47.6034548 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786421, "project_id": 14, "task_id": 93 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3075596, 47.6034548 ], [ -122.3077883, 47.6034581 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786422, "project_id": 14, "task_id": 37 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077862, 47.602623 ], [ -122.3077855, 47.6021604 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786423, "project_id": 14, "task_id": 94 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3075607, 47.6030891 ], [ -122.3075581, 47.6027426 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786424, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264516, 47.6009629 ], [ -122.3262843, 47.6009686 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786425, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264724, 47.600805 ], [ -122.3262691, 47.6008016 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786426, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262352, 47.6009223 ], [ -122.3262284, 47.6008296 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786427, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3255878, 47.6009413 ], [ -122.3260389, 47.6009531 ], [ -122.3262394, 47.6009455 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786428, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262606, 47.6009694 ], [ -122.3262712, 47.6011521 ], [ -122.3262603, 47.6012987 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786429, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262394, 47.6009455 ], [ -122.3262606, 47.6009694 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786430, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262843, 47.6009686 ], [ -122.3262606, 47.6009694 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786431, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262394, 47.6009455 ], [ -122.3262352, 47.6009223 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786432, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265243, 47.6008043 ], [ -122.3264928, 47.6008046 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786433, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264928, 47.6008046 ], [ -122.3264724, 47.600805 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786434, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264928, 47.6008046 ], [ -122.3264871, 47.6007798 ], [ -122.3264878, 47.6004385 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786435, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264809, 47.6009628 ], [ -122.3264579, 47.6010036 ], [ -122.3264612, 47.6011153 ], [ -122.3264739, 47.6011301 ], [ -122.326476, 47.6013037 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786436, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265155, 47.6009515 ], [ -122.3264809, 47.6009628 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786437, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264809, 47.6009628 ], [ -122.3264516, 47.6009629 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786438, "project_id": 13, "task_id": 123 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262263, 47.6008091 ], [ -122.3255831, 47.6008003 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786439, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262691, 47.6008016 ], [ -122.3262453, 47.6008005 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786440, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262263, 47.6008091 ], [ -122.3262284, 47.6008296 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786441, "project_id": 13, "task_id": 360 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262453, 47.6008005 ], [ -122.3262263, 47.6008091 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786442, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262453, 47.6008005 ], [ -122.3262622, 47.6007668 ], [ -122.3262713, 47.6004451 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786443, "project_id": 14, "task_id": 344 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.318232, 47.6022321 ], [ -122.3181685, 47.6021683 ], [ -122.318147, 47.6021541 ], [ -122.3181198, 47.6021426 ], [ -122.3180908, 47.6021308 ], [ -122.3180694, 47.6021192 ], [ -122.3180541, 47.6021056 ], [ -122.3180446, 47.6020922 ], [ -122.3180377, 47.6020773 ], [ -122.3180341, 47.602062 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786444, "project_id": 14, "task_id": 341 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180341, 47.602062 ], [ -122.3180228, 47.6020338 ], [ -122.3180097, 47.6020135 ], [ -122.3179823, 47.6019821 ], [ -122.3178978, 47.6019027 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786445, "project_id": 13, "task_id": 138 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3187193, 47.6026956 ], [ -122.3184591, 47.6024468 ], [ -122.3184118, 47.6024033 ], [ -122.3183852, 47.6023855 ], [ -122.3183428, 47.602364 ], [ -122.3183107, 47.6023453 ], [ -122.3182856, 47.6023254 ], [ -122.3182649, 47.6023012 ], [ -122.31825, 47.6022798 ], [ -122.3182407, 47.6022566 ], [ -122.318232, 47.6022321 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786446, "project_id": 14, "task_id": 116 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311605, 47.6092867 ], [ -122.3114912, 47.609288 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786447, "project_id": 14, "task_id": 50 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114317, 47.6095195 ], [ -122.3114376, 47.6092955 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786448, "project_id": 14, "task_id": 50 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114912, 47.609288 ], [ -122.3114376, 47.6092955 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786449, "project_id": 14, "task_id": 50 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114376, 47.6092955 ], [ -122.3114176, 47.6092843 ], [ -122.3112307, 47.6092856 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786450, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3243341, 47.6052764 ], [ -122.3240874, 47.604983 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786451, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240874, 47.604983 ], [ -122.3240898, 47.6049669 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786452, "project_id": 13, "task_id": 359 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324288, 47.6048662 ], [ -122.3248222, 47.6046413 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786453, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324288, 47.6048662 ], [ -122.3242779, 47.6048564 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786454, "project_id": 13, "task_id": 396 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239748, 47.6048006 ], [ -122.3239307, 47.6048046 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786455, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3242781, 47.60489 ], [ -122.3244941, 47.6051209 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786456, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240898, 47.6049669 ], [ -122.3242549, 47.6048944 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786457, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3242549, 47.6048944 ], [ -122.3242781, 47.60489 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786458, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3242779, 47.6048564 ], [ -122.3241946, 47.6047691 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786459, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3241946, 47.6047691 ], [ -122.3241756, 47.6047569 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786460, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3241756, 47.6047569 ], [ -122.3241267, 47.6047563 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786461, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3241267, 47.6047563 ], [ -122.3241113, 47.6047691 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786462, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3241113, 47.6047691 ], [ -122.3239748, 47.6048006 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786463, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3242781, 47.60489 ], [ -122.324288, 47.6048662 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786464, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240874, 47.604983 ], [ -122.324029, 47.6049771 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786465, "project_id": 13, "task_id": 396 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239307, 47.6048046 ], [ -122.323922, 47.6048299 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786466, "project_id": 13, "task_id": 396 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239658, 47.6048428 ], [ -122.323922, 47.6048299 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786467, "project_id": 13, "task_id": 149 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3241267, 47.6047563 ], [ -122.3229766, 47.6034515 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786468, "project_id": 13, "task_id": 399 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324029, 47.6049771 ], [ -122.3240296, 47.6049575 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786469, "project_id": 14, "task_id": 234 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3178978, 47.6019027 ], [ -122.3177885, 47.6017993 ], [ -122.3177555, 47.6017791 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786470, "project_id": 14, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3113927, 47.6027441 ], [ -122.3113866, 47.6029167 ], [ -122.311384, 47.6033222 ], [ -122.311383, 47.6033858 ], [ -122.3113824, 47.6034667 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786471, "project_id": 14, "task_id": 291 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3111579, 47.6027443 ], [ -122.3111591, 47.6029931 ], [ -122.3111597, 47.6032658 ], [ -122.3111619, 47.6033253 ], [ -122.3111675, 47.6034685 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786472, "project_id": 14, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077865, 47.6035854 ], [ -122.3077819, 47.6042621 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786473, "project_id": 14, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3075586, 47.6035826 ], [ -122.3075515, 47.6042638 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786475, "project_id": 14, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077387, 47.6042625 ], [ -122.3075974, 47.6042637 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786476, "project_id": 14, "task_id": 96 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077451, 47.603575 ], [ -122.3077865, 47.6035854 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786477, "project_id": 14, "task_id": 96 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077883, 47.6034581 ], [ -122.3077869, 47.6035566 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786478, "project_id": 14, "task_id": 95 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077451, 47.603575 ], [ -122.3075708, 47.603585 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786480, "project_id": 14, "task_id": 96 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077869, 47.6035566 ], [ -122.3077865, 47.6035854 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786482, "project_id": 14, "task_id": 50 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114406, 47.6081314 ], [ -122.3114368, 47.6091215 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786483, "project_id": 14, "task_id": 50 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114158, 47.6091313 ], [ -122.3108889, 47.6091337 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786484, "project_id": 14, "task_id": 50 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114368, 47.6091215 ], [ -122.3114957, 47.6091473 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786485, "project_id": 14, "task_id": 50 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114158, 47.6091313 ], [ -122.3114659, 47.6091691 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786486, "project_id": 14, "task_id": 50 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114176, 47.6092843 ], [ -122.3114705, 47.609253 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786487, "project_id": 14, "task_id": 126 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311601, 47.6091461 ], [ -122.3114957, 47.6091473 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786488, "project_id": 14, "task_id": 50 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114659, 47.6091691 ], [ -122.3114705, 47.609253 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786489, "project_id": 14, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116592, 47.6092849 ], [ -122.311646, 47.6092955 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786490, "project_id": 14, "task_id": 115 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116567, 47.6091207 ], [ -122.3116702, 47.609134 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786491, "project_id": 14, "task_id": 50 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114368, 47.6091215 ], [ -122.3114158, 47.6091313 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786492, "project_id": 14, "task_id": 234 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3179054, 47.601603 ], [ -122.3178626, 47.6015685 ], [ -122.3177719, 47.601481 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786493, "project_id": 14, "task_id": 38 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3158406, 47.5965636 ], [ -122.3158599, 47.5965687 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786494, "project_id": 14, "task_id": 38 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3160306, 47.5965891 ], [ -122.3159937, 47.596587 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786495, "project_id": 14, "task_id": 38 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3159937, 47.596587 ], [ -122.3158599, 47.5965687 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786496, "project_id": 14, "task_id": 101 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3141423, 47.5965578 ], [ -122.3141462, 47.5959377 ], [ -122.31416, 47.5959137 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786497, "project_id": 14, "task_id": 38 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3149893, 47.596749 ], [ -122.3144567, 47.5967493 ], [ -122.3144567, 47.596768 ], [ -122.3141941, 47.5967664 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786498, "project_id": 14, "task_id": 101 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3139484, 47.5967661 ], [ -122.3141941, 47.5967664 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786499, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262882, 47.6017746 ], [ -122.3262658, 47.6016492 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786500, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264459, 47.6017906 ], [ -122.326339, 47.6017871 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786501, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3263032, 47.6016247 ], [ -122.3264181, 47.6016168 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786502, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264913, 47.6016545 ], [ -122.3264898, 47.6017776 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786503, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3260345, 47.6016413 ], [ -122.326265, 47.6016377 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786504, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326032, 47.6017882 ], [ -122.3262891, 47.601788 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786505, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262891, 47.601788 ], [ -122.3262882, 47.6017746 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786506, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326265, 47.6016377 ], [ -122.3262658, 47.6016492 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786507, "project_id": 13, "task_id": 443 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3263196, 47.6017887 ], [ -122.326333, 47.601811 ], [ -122.3263352, 47.6019307 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786508, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262891, 47.601788 ], [ -122.3263196, 47.6017887 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786509, "project_id": 13, "task_id": 443 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264381, 47.6019156 ], [ -122.3264425, 47.6018135 ], [ -122.326464, 47.601798 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786510, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264889, 47.6017889 ], [ -122.3267194, 47.6017963 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786511, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326464, 47.601798 ], [ -122.3264889, 47.6017889 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786512, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264898, 47.6017776 ], [ -122.3264889, 47.6017889 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786513, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326715, 47.601634 ], [ -122.326492, 47.601633 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786514, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326492, 47.601633 ], [ -122.3264913, 47.6016545 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786515, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326492, 47.601633 ], [ -122.3264781, 47.6016131 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786516, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264781, 47.6016131 ], [ -122.326476, 47.6013037 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786517, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264781, 47.6016131 ], [ -122.3264181, 47.6016168 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786518, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262603, 47.6012987 ], [ -122.3262593, 47.6014801 ], [ -122.3262645, 47.6016224 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786519, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262645, 47.6016224 ], [ -122.326265, 47.6016377 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786520, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3263032, 47.6016247 ], [ -122.3262645, 47.6016224 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786521, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326464, 47.601798 ], [ -122.3264459, 47.6017906 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786522, "project_id": 13, "task_id": 442 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326339, 47.6017871 ], [ -122.3263196, 47.6017887 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786523, "project_id": 14, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090937, 47.6034618 ], [ -122.3095937, 47.603462 ], [ -122.3098778, 47.6034621 ], [ -122.310082, 47.6034631 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786524, "project_id": 14, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090934, 47.6035835 ], [ -122.3095902, 47.6035839 ], [ -122.310083, 47.6035842 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786525, "project_id": 14, "task_id": 361 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3111657, 47.6034898 ], [ -122.311163, 47.6035672 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786527, "project_id": 14, "task_id": 37 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3075586, 47.6021602 ], [ -122.3075582, 47.6017724 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786528, "project_id": 14, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3171191, 47.5974388 ], [ -122.3166458, 47.5974404 ], [ -122.3152954, 47.597425 ], [ -122.3143786, 47.5974221 ], [ -122.3139526, 47.5974196 ], [ -122.3135272, 47.5974219 ], [ -122.312864, 47.5974148 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786529, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3230281, 47.6051941 ], [ -122.3225334, 47.6046472 ], [ -122.3225045, 47.6046151 ], [ -122.3224137, 47.6045147 ], [ -122.3223918, 47.6044908 ], [ -122.3220464, 47.6041164 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786530, "project_id": 14, "task_id": 63 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3170754, 47.5982678 ], [ -122.3160885, 47.5982688 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786531, "project_id": 14, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3177719, 47.601481 ], [ -122.3176233, 47.6013388 ], [ -122.3173645, 47.6010869 ], [ -122.3173515, 47.6010727 ], [ -122.3173415, 47.6010564 ], [ -122.3173253, 47.6010335 ], [ -122.3173068, 47.6010134 ], [ -122.3171876, 47.6008974 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786532, "project_id": 14, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.318078, 47.6008491 ], [ -122.3179671, 47.6008396 ], [ -122.317703, 47.6008383 ], [ -122.3175566, 47.6008388 ], [ -122.3173785, 47.6008402 ], [ -122.317351, 47.6008483 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786533, "project_id": 14, "task_id": 235 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317588, 47.6016024 ], [ -122.3175445, 47.6015603 ], [ -122.3175034, 47.60152 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786534, "project_id": 13, "task_id": 457 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3267194, 47.6017963 ], [ -122.3275427, 47.6017942 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786535, "project_id": 13, "task_id": 457 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.326715, 47.601634 ], [ -122.327553, 47.6016436 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786536, "project_id": 13, "task_id": 457 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275455, 47.6015079 ], [ -122.327553, 47.6016436 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786537, "project_id": 13, "task_id": 457 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327553, 47.6016436 ], [ -122.3276106, 47.6016444 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786538, "project_id": 13, "task_id": 457 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327553, 47.6016436 ], [ -122.3275427, 47.6017942 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786539, "project_id": 13, "task_id": 459 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275427, 47.6017942 ], [ -122.3277942, 47.6017938 ], [ -122.3281455, 47.6017933 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786540, "project_id": 13, "task_id": 457 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275427, 47.6017942 ], [ -122.3275074, 47.6018844 ], [ -122.3275109, 47.6019721 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786541, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3222518, 47.6045811 ], [ -122.3221983, 47.6045695 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786542, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223462, 47.6046723 ], [ -122.3223258, 47.604693 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786543, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223258, 47.604693 ], [ -122.3223348, 47.6047037 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786544, "project_id": 14, "task_id": 54 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088641, 47.6035834 ], [ -122.3088618, 47.6037755 ], [ -122.3088606, 47.6042682 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786545, "project_id": 14, "task_id": 54 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088641, 47.6035834 ], [ -122.3088668, 47.6035575 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786546, "project_id": 14, "task_id": 54 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077865, 47.6035854 ], [ -122.3082651, 47.603577 ], [ -122.3088641, 47.6035834 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786547, "project_id": 14, "task_id": 53 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3089153, 47.6035834 ], [ -122.309039, 47.6035835 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786548, "project_id": 14, "task_id": 54 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088668, 47.6035575 ], [ -122.3088649, 47.6034834 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786549, "project_id": 14, "task_id": 91 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088607, 47.6026178 ], [ -122.3088634, 47.60194 ], [ -122.3088647, 47.6017642 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786550, "project_id": 14, "task_id": 54 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088641, 47.6035834 ], [ -122.3089153, 47.6035834 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786551, "project_id": 14, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088606, 47.6042682 ], [ -122.3077819, 47.6042621 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786552, "project_id": 14, "task_id": 54 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077883, 47.6034581 ], [ -122.3085142, 47.6034611 ], [ -122.3088709, 47.6034614 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786553, "project_id": 14, "task_id": 54 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088928, 47.6034614 ], [ -122.3090372, 47.6034615 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786554, "project_id": 14, "task_id": 54 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088649, 47.6034834 ], [ -122.3088709, 47.6034614 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786555, "project_id": 14, "task_id": 54 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088709, 47.6034614 ], [ -122.3088928, 47.6034614 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786556, "project_id": 14, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090372, 47.6034615 ], [ -122.3090937, 47.6034618 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786557, "project_id": 14, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090937, 47.6034618 ], [ -122.3090961, 47.6034849 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786558, "project_id": 14, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090961, 47.6034849 ], [ -122.3090961, 47.6035582 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786559, "project_id": 14, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090856, 47.6026245 ], [ -122.3090869, 47.6021694 ], [ -122.3090848, 47.6017599 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786560, "project_id": 14, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090961, 47.6035582 ], [ -122.3090934, 47.6035835 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786561, "project_id": 14, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.309039, 47.6035835 ], [ -122.3090934, 47.6035835 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786562, "project_id": 14, "task_id": 53 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090934, 47.6035835 ], [ -122.3090899, 47.6037789 ], [ -122.3090828, 47.6041432 ], [ -122.309082, 47.6042712 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786563, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103598, 47.6026043 ], [ -122.3103632, 47.6020825 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786564, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101689, 47.6026008 ], [ -122.3101574, 47.6017615 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786565, "project_id": 14, "task_id": 91 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088654, 47.6027469 ], [ -122.3077849, 47.60274 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786566, "project_id": 14, "task_id": 91 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088607, 47.6026178 ], [ -122.3077862, 47.602623 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786567, "project_id": 14, "task_id": 94 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077709, 47.6027255 ], [ -122.3075837, 47.6027262 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786568, "project_id": 14, "task_id": 37 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077706, 47.6026405 ], [ -122.307581, 47.6026368 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786569, "project_id": 14, "task_id": 94 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077863, 47.6030831 ], [ -122.3077849, 47.60274 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786570, "project_id": 14, "task_id": 97 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077706, 47.6026405 ], [ -122.3077862, 47.602623 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786571, "project_id": 14, "task_id": 97 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077709, 47.6027255 ], [ -122.3077706, 47.6026405 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786572, "project_id": 14, "task_id": 97 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077849, 47.60274 ], [ -122.3077709, 47.6027255 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786575, "project_id": 14, "task_id": 37 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3075572, 47.6026225 ], [ -122.3075594, 47.6025729 ], [ -122.3075586, 47.6021602 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786579, "project_id": 14, "task_id": 143 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3091219, 47.6007706 ], [ -122.3095943, 47.6007695 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786580, "project_id": 14, "task_id": 143 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3091221, 47.6009233 ], [ -122.3095938, 47.600923 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786581, "project_id": 14, "task_id": 143 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090939, 47.6009233 ], [ -122.3091221, 47.6009233 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786582, "project_id": 14, "task_id": 143 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3091221, 47.6009233 ], [ -122.3091207, 47.600893 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786583, "project_id": 14, "task_id": 143 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090939, 47.6009233 ], [ -122.3090642, 47.6009245 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786584, "project_id": 14, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088674, 47.6009219 ], [ -122.3088609, 47.6015948 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786585, "project_id": 14, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3160885, 47.5982688 ], [ -122.3159074, 47.5982676 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786586, "project_id": 14, "task_id": 61 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3159074, 47.5982676 ], [ -122.315433, 47.5982662 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786587, "project_id": 14, "task_id": 41 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.315433, 47.5982662 ], [ -122.3149646, 47.5982641 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786588, "project_id": 14, "task_id": 219 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103016, 47.6035833 ], [ -122.3104764, 47.603584 ], [ -122.3109685, 47.6035847 ], [ -122.3111636, 47.6035895 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786589, "project_id": 14, "task_id": 140 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310083, 47.6035842 ], [ -122.3101364, 47.6035843 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786590, "project_id": 14, "task_id": 140 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310083, 47.6035842 ], [ -122.310083, 47.6035602 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786591, "project_id": 14, "task_id": 140 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310083, 47.6035602 ], [ -122.3100825, 47.6034845 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786592, "project_id": 14, "task_id": 140 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3100825, 47.6034845 ], [ -122.310082, 47.6034631 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786593, "project_id": 14, "task_id": 219 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103066, 47.6034621 ], [ -122.3104775, 47.6034633 ], [ -122.3109685, 47.6034668 ], [ -122.3111675, 47.6034685 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786594, "project_id": 14, "task_id": 140 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310082, 47.6034631 ], [ -122.310137, 47.6034634 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786595, "project_id": 14, "task_id": 140 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310137, 47.6034634 ], [ -122.310252, 47.6034616 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786596, "project_id": 14, "task_id": 219 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3102818, 47.603462 ], [ -122.3103066, 47.6034621 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786597, "project_id": 14, "task_id": 219 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101364, 47.6035843 ], [ -122.3102548, 47.6035836 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786598, "project_id": 14, "task_id": 219 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3102804, 47.6035661 ], [ -122.3102814, 47.6034844 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786599, "project_id": 14, "task_id": 219 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103016, 47.6035833 ], [ -122.3102804, 47.6035661 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786600, "project_id": 14, "task_id": 219 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3102548, 47.6035836 ], [ -122.3103016, 47.6035833 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786601, "project_id": 14, "task_id": 219 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3102814, 47.6034844 ], [ -122.3102818, 47.603462 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786602, "project_id": 14, "task_id": 219 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310252, 47.6034616 ], [ -122.3102818, 47.603462 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786603, "project_id": 14, "task_id": 140 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310083, 47.6035842 ], [ -122.3100821, 47.6039305 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786604, "project_id": 14, "task_id": 219 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103047, 47.6039322 ], [ -122.3103016, 47.6035833 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786605, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103066, 47.6034621 ], [ -122.310311, 47.6027554 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786606, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310082, 47.6034631 ], [ -122.3100868, 47.6027524 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786607, "project_id": 13, "task_id": 273 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3216659, 47.6039882 ], [ -122.3221983, 47.6045695 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786608, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3222518, 47.6045811 ], [ -122.3223724, 47.6045267 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786609, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223724, 47.6045267 ], [ -122.3223918, 47.6044908 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786610, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223462, 47.6046723 ], [ -122.3224506, 47.6046219 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786611, "project_id": 13, "task_id": 151 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3224506, 47.6046219 ], [ -122.3225045, 47.6046151 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786612, "project_id": 14, "task_id": 88 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.309039, 47.6027401 ], [ -122.308921, 47.6027423 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786613, "project_id": 14, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.309035, 47.6026244 ], [ -122.308914, 47.6026239 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786614, "project_id": 14, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.309039, 47.6027401 ], [ -122.3090903, 47.602743 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786615, "project_id": 14, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.309035, 47.6026244 ], [ -122.3090856, 47.6026245 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786616, "project_id": 14, "task_id": 59 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090937, 47.6034618 ], [ -122.3090923, 47.6031069 ], [ -122.3090903, 47.602743 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786617, "project_id": 14, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.309088, 47.6027203 ], [ -122.3090865, 47.6026453 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786618, "project_id": 14, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090903, 47.602743 ], [ -122.309088, 47.6027203 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786619, "project_id": 14, "task_id": 89 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090865, 47.6026453 ], [ -122.3090856, 47.6026245 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786620, "project_id": 14, "task_id": 54 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088709, 47.6034614 ], [ -122.3088654, 47.6027469 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786621, "project_id": 14, "task_id": 91 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088654, 47.6027469 ], [ -122.308921, 47.6027423 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786622, "project_id": 14, "task_id": 91 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.308921, 47.6027423 ], [ -122.308914, 47.6026239 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786623, "project_id": 14, "task_id": 91 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.308914, 47.6026239 ], [ -122.3088607, 47.6026178 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786624, "project_id": 14, "task_id": 40 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3149646, 47.5982641 ], [ -122.3144488, 47.5982626 ], [ -122.3135382, 47.5982553 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786625, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3261993, 47.5999745 ], [ -122.326204, 47.6000982 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786626, "project_id": 13, "task_id": 248 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262539, 47.5999316 ], [ -122.3262597, 47.5996038 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786627, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264683, 47.5999323 ], [ -122.3262788, 47.5999314 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786628, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265323, 47.5999736 ], [ -122.3265334, 47.6001025 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786629, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264819, 47.6001098 ], [ -122.3262797, 47.6001152 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786630, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264878, 47.6004385 ], [ -122.3264893, 47.6001207 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786631, "project_id": 13, "task_id": 249 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3262497, 47.6001176 ], [ -122.3262745, 47.600229 ], [ -122.3262713, 47.6004451 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786632, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090903, 47.602743 ], [ -122.3098126, 47.6027432 ], [ -122.3100675, 47.6027416 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786633, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101284, 47.602622 ], [ -122.3094605, 47.602622 ], [ -122.3090856, 47.6026245 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786634, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3255831, 47.6008003 ], [ -122.3253001, 47.6008019 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786635, "project_id": 14, "task_id": 361 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3111636, 47.6035895 ], [ -122.3111519, 47.6039337 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786636, "project_id": 14, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311344, 47.6034679 ], [ -122.311205, 47.6034666 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786637, "project_id": 14, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3113824, 47.6034667 ], [ -122.3113823, 47.6034883 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786638, "project_id": 14, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3113823, 47.6034883 ], [ -122.3113858, 47.6035615 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786639, "project_id": 14, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3113853, 47.6035879 ], [ -122.3113803, 47.6039424 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786640, "project_id": 14, "task_id": 361 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3113278, 47.603587 ], [ -122.3112, 47.6035875 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786641, "project_id": 14, "task_id": 361 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3112, 47.6035875 ], [ -122.3111636, 47.6035895 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786642, "project_id": 14, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3113278, 47.603587 ], [ -122.3113853, 47.6035879 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786643, "project_id": 14, "task_id": 361 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311205, 47.6034666 ], [ -122.3111675, 47.6034685 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786644, "project_id": 14, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3113824, 47.6034667 ], [ -122.311344, 47.6034679 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786645, "project_id": 14, "task_id": 286 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3113858, 47.6035615 ], [ -122.3113853, 47.6035879 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786646, "project_id": 14, "task_id": 361 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3111675, 47.6034685 ], [ -122.3111657, 47.6034898 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786647, "project_id": 14, "task_id": 361 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311163, 47.6035672 ], [ -122.3111636, 47.6035895 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786648, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103301, 47.6027234 ], [ -122.3103521, 47.6026331 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786649, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310334, 47.6026112 ], [ -122.310207, 47.6026065 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786650, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310144, 47.6026436 ], [ -122.3101, 47.6027201 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786651, "project_id": 14, "task_id": 210 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3102881, 47.6027435 ], [ -122.3101344, 47.6027427 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786652, "project_id": 14, "task_id": 406 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195453, 47.5992981 ], [ -122.3195334, 47.5992868 ], [ -122.3194944, 47.5992865 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786653, "project_id": 13, "task_id": 7 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197755, 47.5990786 ], [ -122.3203336, 47.5990794 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786654, "project_id": 13, "task_id": 7 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197806, 47.5992984 ], [ -122.3203348, 47.5993 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786655, "project_id": 13, "task_id": 7 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3197806, 47.5992984 ], [ -122.319741, 47.5993128 ], [ -122.3197348, 47.5996694 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786656, "project_id": 13, "task_id": 7 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195453, 47.5992981 ], [ -122.3195465, 47.5996674 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786657, "project_id": 13, "task_id": 7 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319772, 47.5992767 ], [ -122.3197806, 47.5992984 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786658, "project_id": 14, "task_id": 406 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195628, 47.5992976 ], [ -122.3195453, 47.5992981 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786659, "project_id": 14, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3113853, 47.6035879 ], [ -122.3127775, 47.6035823 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786660, "project_id": 14, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3113824, 47.6034667 ], [ -122.3121202, 47.6034654 ], [ -122.3127756, 47.6034586 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786661, "project_id": 14, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129962, 47.6034523 ], [ -122.3132711, 47.6034519 ], [ -122.314097, 47.6034595 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786662, "project_id": 14, "task_id": 295 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3128278, 47.6034568 ], [ -122.3129532, 47.6034534 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786663, "project_id": 14, "task_id": 101 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.313929, 47.596578 ], [ -122.3138514, 47.5965775 ], [ -122.3134845, 47.5965781 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786664, "project_id": 14, "task_id": 101 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3139788, 47.5965583 ], [ -122.3139934, 47.5965632 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786665, "project_id": 14, "task_id": 101 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.313929, 47.596578 ], [ -122.3139433, 47.5965952 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786666, "project_id": 14, "task_id": 101 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3139803, 47.5965235 ], [ -122.3139788, 47.5965583 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786667, "project_id": 14, "task_id": 101 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3139788, 47.5965583 ], [ -122.3139623, 47.5965709 ], [ -122.3139438, 47.596577 ], [ -122.313929, 47.596578 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786668, "project_id": 14, "task_id": 101 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3141423, 47.5965578 ], [ -122.3141277, 47.5965638 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786669, "project_id": 14, "task_id": 101 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3139484, 47.5967661 ], [ -122.3134877, 47.5967698 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786670, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252186, 47.5999574 ], [ -122.3252194, 47.5999691 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786671, "project_id": 13, "task_id": 67 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249357, 47.6001153 ], [ -122.3246932, 47.6001135 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786672, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252186, 47.5999574 ], [ -122.3251852, 47.5999578 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786673, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251852, 47.5999578 ], [ -122.3251533, 47.5999594 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786674, "project_id": 13, "task_id": 14 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251852, 47.5999578 ], [ -122.325184, 47.5998735 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786675, "project_id": 13, "task_id": 10 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3253001, 47.6008019 ], [ -122.3251366, 47.6007999 ], [ -122.3250994, 47.6008101 ], [ -122.3250684, 47.6008322 ], [ -122.3250587, 47.600859 ], [ -122.3250596, 47.6008835 ], [ -122.3250764, 47.6009109 ], [ -122.3251089, 47.6009285 ], [ -122.3251519, 47.6009389 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786676, "project_id": 14, "task_id": 226 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103961, 47.6020483 ], [ -122.3103945, 47.6017617 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786677, "project_id": 14, "task_id": 289 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103632, 47.6020825 ], [ -122.3103961, 47.6020483 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786678, "project_id": 14, "task_id": 209 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129823, 47.606284 ], [ -122.3135108, 47.60629 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786679, "project_id": 14, "task_id": 130 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129824, 47.6060971 ], [ -122.312986, 47.6052749 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786680, "project_id": 14, "task_id": 130 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127675, 47.6060976 ], [ -122.3127771, 47.6058084 ], [ -122.312773, 47.6052726 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786681, "project_id": 13, "task_id": 67 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3246932, 47.6001135 ], [ -122.324056, 47.6001179 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786682, "project_id": 14, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3143114, 47.608118 ], [ -122.3142834, 47.6081171 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786683, "project_id": 14, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142833, 47.6081395 ], [ -122.3142834, 47.6081171 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786684, "project_id": 14, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142529, 47.6081171 ], [ -122.3142834, 47.6081171 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786685, "project_id": 14, "task_id": 285 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142824, 47.6079408 ], [ -122.3142896, 47.6073099 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786686, "project_id": 14, "task_id": 284 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140398, 47.6079411 ], [ -122.3140479, 47.6079258 ], [ -122.3140549, 47.6078387 ], [ -122.314062, 47.6073108 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786687, "project_id": 13, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193294, 47.6042809 ], [ -122.3193398, 47.6039553 ], [ -122.3193379, 47.6036005 ], [ -122.3193123, 47.6035856 ], [ -122.3188053, 47.6035793 ], [ -122.3182306, 47.6035824 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786688, "project_id": 14, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3130015, 47.6035739 ], [ -122.3140928, 47.6035741 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786689, "project_id": 14, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3128223, 47.6035815 ], [ -122.3129456, 47.6035758 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786690, "project_id": 14, "task_id": 295 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3130015, 47.6035739 ], [ -122.313001, 47.6035488 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786691, "project_id": 14, "task_id": 295 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.313001, 47.6035488 ], [ -122.3129969, 47.6034738 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786692, "project_id": 14, "task_id": 295 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129532, 47.6034534 ], [ -122.3129962, 47.6034523 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786693, "project_id": 14, "task_id": 295 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129969, 47.6034738 ], [ -122.3129962, 47.6034523 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786694, "project_id": 14, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127756, 47.6034586 ], [ -122.3128278, 47.6034568 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786695, "project_id": 14, "task_id": 295 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129456, 47.6035758 ], [ -122.3130015, 47.6035739 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786696, "project_id": 14, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127751, 47.6034875 ], [ -122.3127789, 47.6035638 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786697, "project_id": 14, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127789, 47.6035638 ], [ -122.3127775, 47.6035823 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786698, "project_id": 14, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127756, 47.6034586 ], [ -122.3127751, 47.6034875 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786699, "project_id": 14, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127775, 47.6035823 ], [ -122.3128223, 47.6035815 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786700, "project_id": 14, "task_id": 216 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3130015, 47.6035739 ], [ -122.312995, 47.6040043 ], [ -122.3129976, 47.6042846 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786701, "project_id": 14, "task_id": 368 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127775, 47.6035823 ], [ -122.3127774, 47.6042398 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786702, "project_id": 14, "task_id": 217 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129976, 47.6042846 ], [ -122.313583, 47.6042867 ], [ -122.3140888, 47.6042879 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786703, "project_id": 13, "task_id": 195 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3203348, 47.5993 ], [ -122.3214957, 47.599303 ], [ -122.322204, 47.5992954 ], [ -122.3223465, 47.5992941 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786704, "project_id": 13, "task_id": 186 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223385, 47.599067 ], [ -122.3221879, 47.5990646 ], [ -122.3215028, 47.5990729 ], [ -122.3208303, 47.5990785 ], [ -122.3203336, 47.5990794 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786705, "project_id": 13, "task_id": 186 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225766, 47.5990718 ], [ -122.3225686, 47.5990962 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786706, "project_id": 13, "task_id": 195 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225726, 47.5992928 ], [ -122.3223465, 47.5992941 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786707, "project_id": 13, "task_id": 15 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324056, 47.6001179 ], [ -122.3235618, 47.6001155 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786709, "project_id": 13, "task_id": 15 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323893, 47.5999571 ], [ -122.3238877, 47.5999289 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786711, "project_id": 13, "task_id": 15 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236572, 47.5999591 ], [ -122.3236448, 47.5999555 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786712, "project_id": 13, "task_id": 15 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236448, 47.5999555 ], [ -122.3236488, 47.599931 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786713, "project_id": 13, "task_id": 14 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.325184, 47.5998735 ], [ -122.3251873, 47.5997588 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786714, "project_id": 13, "task_id": 83 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251873, 47.5997588 ], [ -122.3251816, 47.5993376 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786715, "project_id": 14, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090826, 47.6042963 ], [ -122.3090843, 47.6043719 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786716, "project_id": 14, "task_id": 7 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090849, 47.6044014 ], [ -122.3090855, 47.6045591 ], [ -122.3090783, 47.6054297 ], [ -122.3090581, 47.6060867 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786717, "project_id": 14, "task_id": 7 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088413, 47.6060824 ], [ -122.3088488, 47.6053525 ], [ -122.3088486, 47.6052844 ], [ -122.308855, 47.6043965 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786718, "project_id": 14, "task_id": 7 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090323, 47.604395 ], [ -122.3089156, 47.6043965 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786719, "project_id": 14, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090849, 47.6044014 ], [ -122.3090323, 47.604395 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786720, "project_id": 14, "task_id": 7 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3089156, 47.6043965 ], [ -122.308855, 47.6043965 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786721, "project_id": 14, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088552, 47.6043688 ], [ -122.3088783, 47.6042926 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786722, "project_id": 14, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.308855, 47.6043965 ], [ -122.3088552, 47.6043688 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786723, "project_id": 14, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088783, 47.6042926 ], [ -122.3088606, 47.6042682 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786724, "project_id": 14, "task_id": 52 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.309049, 47.6042877 ], [ -122.3089116, 47.6042701 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786725, "project_id": 14, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.309082, 47.6042712 ], [ -122.309049, 47.6042877 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786726, "project_id": 14, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.309082, 47.6042712 ], [ -122.3090826, 47.6042963 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786727, "project_id": 14, "task_id": 57 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090843, 47.6043719 ], [ -122.3090849, 47.6044014 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786728, "project_id": 14, "task_id": 52 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3089116, 47.6042701 ], [ -122.3088606, 47.6042682 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786729, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3268017, 47.6045848 ], [ -122.3266097, 47.6043544 ], [ -122.3263867, 47.6041064 ], [ -122.3263237, 47.6039915 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786730, "project_id": 13, "task_id": 43 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195221, 47.6042938 ], [ -122.3195148, 47.6039469 ], [ -122.3195133, 47.6035829 ], [ -122.3194581, 47.6035243 ], [ -122.3193526, 47.6034661 ], [ -122.3182332, 47.6034579 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786731, "project_id": 13, "task_id": 250 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252107, 47.5993013 ], [ -122.326199, 47.5993018 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786732, "project_id": 14, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088747, 47.5999395 ], [ -122.3088758, 47.5998077 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786733, "project_id": 14, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088747, 47.6000874 ], [ -122.3075974, 47.6000829 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786734, "project_id": 14, "task_id": 155 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3161779, 47.5999467 ], [ -122.3160529, 47.5999496 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786735, "project_id": 14, "task_id": 231 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3160529, 47.5999496 ], [ -122.3160242, 47.599966 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786736, "project_id": 14, "task_id": 155 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3161052, 47.6000142 ], [ -122.3160242, 47.599966 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786737, "project_id": 14, "task_id": 155 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3161052, 47.6000142 ], [ -122.315903, 47.6001032 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786738, "project_id": 14, "task_id": 231 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3160242, 47.599966 ], [ -122.3158535, 47.599865 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786739, "project_id": 14, "task_id": 155 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3161104, 47.6002735 ], [ -122.3158789, 47.6001211 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786740, "project_id": 14, "task_id": 224 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101592, 47.6016129 ], [ -122.3101639, 47.6012992 ], [ -122.310173, 47.6009241 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786741, "project_id": 14, "task_id": 224 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103963, 47.6016123 ], [ -122.3103982, 47.6009249 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786742, "project_id": 14, "task_id": 226 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103945, 47.6017617 ], [ -122.3103972, 47.6017479 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786743, "project_id": 14, "task_id": 226 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103945, 47.6017617 ], [ -122.3103455, 47.6017599 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786744, "project_id": 14, "task_id": 36 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090848, 47.6017599 ], [ -122.3090548, 47.6017673 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786745, "project_id": 14, "task_id": 55 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.308855, 47.6043965 ], [ -122.3077813, 47.6043929 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786746, "project_id": 13, "task_id": 325 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249271, 47.5993067 ], [ -122.3247096, 47.5993105 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786747, "project_id": 13, "task_id": 325 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249278, 47.5990851 ], [ -122.324711, 47.5990804 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786748, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252203, 47.5990976 ], [ -122.325229, 47.5991306 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786749, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251718, 47.5990718 ], [ -122.3251778, 47.598767 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786750, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251417, 47.5990629 ], [ -122.3251718, 47.5990718 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786751, "project_id": 13, "task_id": 327 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3252203, 47.5990976 ], [ -122.3251718, 47.5990718 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786752, "project_id": 14, "task_id": 228 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3095938, 47.600923 ], [ -122.310173, 47.6009241 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786753, "project_id": 14, "task_id": 228 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3095943, 47.6007695 ], [ -122.3101683, 47.6007702 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786755, "project_id": 14, "task_id": 228 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310173, 47.6009241 ], [ -122.310218, 47.6009109 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786756, "project_id": 14, "task_id": 228 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101683, 47.6007702 ], [ -122.3101713, 47.6007994 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786757, "project_id": 14, "task_id": 228 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101683, 47.6007702 ], [ -122.310227, 47.6007709 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786758, "project_id": 14, "task_id": 228 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101792, 47.6008947 ], [ -122.3101713, 47.6007994 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786759, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3247096, 47.5993105 ], [ -122.3240616, 47.5993087 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786760, "project_id": 13, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324711, 47.5990804 ], [ -122.3240559, 47.5990796 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786761, "project_id": 14, "task_id": 376 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3157874, 47.6000943 ], [ -122.315253, 47.600095 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786762, "project_id": 14, "task_id": 308 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155466, 47.5999429 ], [ -122.3155677, 47.5999291 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786763, "project_id": 14, "task_id": 308 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155677, 47.5999291 ], [ -122.3156089, 47.5999494 ], [ -122.3157188, 47.6000023 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786764, "project_id": 13, "task_id": 65 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238877, 47.5999289 ], [ -122.3238811, 47.599789 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786765, "project_id": 13, "task_id": 65 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236488, 47.599931 ], [ -122.3236481, 47.5997819 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786766, "project_id": 13, "task_id": 66 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236481, 47.5997819 ], [ -122.3236456, 47.599653 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786767, "project_id": 13, "task_id": 66 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238811, 47.599789 ], [ -122.3238803, 47.599653 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786770, "project_id": 14, "task_id": 56 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077811, 47.6042813 ], [ -122.3077813, 47.6043694 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786774, "project_id": 14, "task_id": 56 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077819, 47.6042621 ], [ -122.3077387, 47.6042625 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786775, "project_id": 14, "task_id": 56 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077819, 47.6042621 ], [ -122.3077811, 47.6042813 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786776, "project_id": 14, "task_id": 56 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077813, 47.6043694 ], [ -122.3077813, 47.6043929 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786777, "project_id": 14, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077341, 47.6043927 ], [ -122.3075979, 47.6043923 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786779, "project_id": 14, "task_id": 56 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077813, 47.6043929 ], [ -122.3077341, 47.6043927 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786780, "project_id": 14, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3077813, 47.6043929 ], [ -122.307771, 47.6060875 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786781, "project_id": 14, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3075379, 47.6060815 ], [ -122.3075411, 47.6058318 ], [ -122.3075469, 47.6055239 ], [ -122.3075528, 47.6043919 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786782, "project_id": 13, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236129, 47.6031703 ], [ -122.3229766, 47.6034515 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786783, "project_id": 13, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3243236, 47.6026966 ], [ -122.3239354, 47.6028573 ], [ -122.3228457, 47.6033089 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786784, "project_id": 13, "task_id": 66 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238803, 47.599653 ], [ -122.323881, 47.5995611 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786785, "project_id": 13, "task_id": 66 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236456, 47.599653 ], [ -122.3236476, 47.5995602 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786786, "project_id": 13, "task_id": 17 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323881, 47.5995611 ], [ -122.3238852, 47.5993807 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786787, "project_id": 13, "task_id": 17 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236476, 47.5995602 ], [ -122.3236497, 47.5993826 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786788, "project_id": 14, "task_id": 231 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3158535, 47.599865 ], [ -122.3156693, 47.59977 ], [ -122.3155008, 47.5996898 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786789, "project_id": 13, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236129, 47.6031703 ], [ -122.3240166, 47.6030089 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786790, "project_id": 13, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324308, 47.6031638 ], [ -122.3242578, 47.6031024 ], [ -122.3242391, 47.6030757 ], [ -122.3242298, 47.6030465 ], [ -122.3242298, 47.6030198 ], [ -122.3242239, 47.6029954 ], [ -122.3242146, 47.6029773 ], [ -122.3241901, 47.6029599 ], [ -122.3241516, 47.6029473 ], [ -122.3241165, 47.6029466 ], [ -122.3240862, 47.6029497 ], [ -122.3240652, 47.6029568 ], [ -122.3240552, 47.6029611 ], [ -122.3240482, 47.6029655 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786791, "project_id": 13, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240297, 47.6029496 ], [ -122.3239647, 47.6028844 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786792, "project_id": 13, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240482, 47.6029655 ], [ -122.3240297, 47.6029496 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786793, "project_id": 13, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240166, 47.6030089 ], [ -122.3240273, 47.6029855 ], [ -122.3240384, 47.6029726 ], [ -122.3240482, 47.6029655 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786794, "project_id": 13, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239647, 47.6028844 ], [ -122.3239354, 47.6028573 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786795, "project_id": 13, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249984, 47.6026041 ], [ -122.3246731, 47.6022944 ], [ -122.3246, 47.6022272 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786796, "project_id": 14, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.312999, 47.6016059 ], [ -122.3130004, 47.6013199 ], [ -122.3129987, 47.6009282 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786797, "project_id": 13, "task_id": 448 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.327453, 47.603332 ], [ -122.3272735, 47.6031385 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786798, "project_id": 13, "task_id": 448 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3272912, 47.6034065 ], [ -122.3271499, 47.6032546 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786799, "project_id": 14, "task_id": 12 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173814, 47.5982691 ], [ -122.3195183, 47.5982664 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786800, "project_id": 14, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3170639, 47.5993132 ], [ -122.3145552, 47.5993177 ], [ -122.3145226, 47.5993261 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786801, "project_id": 14, "task_id": 42 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3170947, 47.5991005 ], [ -122.3160041, 47.5990934 ], [ -122.3144594, 47.5990975 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786805, "project_id": 14, "task_id": 377 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155008, 47.5996898 ], [ -122.3152423, 47.5995819 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786806, "project_id": 14, "task_id": 377 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3152423, 47.5995819 ], [ -122.3150782, 47.5995217 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786807, "project_id": 14, "task_id": 377 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3150782, 47.5995217 ], [ -122.3148432, 47.5994396 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786808, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239117, 47.5992614 ], [ -122.3239304, 47.5991288 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786809, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238368, 47.599337 ], [ -122.3236884, 47.599312 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786810, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236579, 47.5992846 ], [ -122.3236436, 47.5991195 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786811, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236523, 47.5993096 ], [ -122.3235013, 47.599307 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786812, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236497, 47.5993826 ], [ -122.3236523, 47.5993096 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786813, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236579, 47.5992846 ], [ -122.3236523, 47.5993096 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786814, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236523, 47.5993096 ], [ -122.3236884, 47.599312 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786815, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240616, 47.5993087 ], [ -122.3238932, 47.5993065 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786816, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239117, 47.5992614 ], [ -122.3238932, 47.5993065 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786817, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238368, 47.599337 ], [ -122.3238838, 47.5993366 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786818, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238838, 47.5993366 ], [ -122.3238852, 47.5993807 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786819, "project_id": 13, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238932, 47.5993065 ], [ -122.3238838, 47.5993366 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786820, "project_id": 14, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129981, 47.6008998 ], [ -122.3129987, 47.6009282 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786821, "project_id": 14, "task_id": 146 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129563, 47.600922 ], [ -122.3129987, 47.6009282 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786822, "project_id": 14, "task_id": 8 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3090626, 47.6062709 ], [ -122.3090749, 47.6066786 ], [ -122.3090689, 47.6071925 ], [ -122.3090617, 47.6074917 ], [ -122.3090521, 47.6079055 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786823, "project_id": 14, "task_id": 255 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182306, 47.6035824 ], [ -122.3182285, 47.6035586 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786824, "project_id": 14, "task_id": 255 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182282, 47.603584 ], [ -122.318184, 47.6035835 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786825, "project_id": 14, "task_id": 255 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182306, 47.6035824 ], [ -122.3182282, 47.603584 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786826, "project_id": 14, "task_id": 233 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3148432, 47.5994396 ], [ -122.3145226, 47.5993261 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786827, "project_id": 14, "task_id": 233 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3145226, 47.5993261 ], [ -122.3145019, 47.5993195 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786828, "project_id": 14, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142931, 47.5994202 ], [ -122.314304, 47.5994102 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786829, "project_id": 14, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314506, 47.5993029 ], [ -122.3143506, 47.5991203 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786830, "project_id": 14, "task_id": 255 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182265, 47.6034556 ], [ -122.3182296, 47.6030994 ], [ -122.3182253, 47.6027547 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786831, "project_id": 13, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236965, 47.5990778 ], [ -122.3238357, 47.5990691 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786832, "project_id": 13, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236436, 47.5991195 ], [ -122.3236502, 47.5990835 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786833, "project_id": 13, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236502, 47.5990835 ], [ -122.3236965, 47.5990778 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786834, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236502, 47.5990835 ], [ -122.323651, 47.598752 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786835, "project_id": 13, "task_id": 85 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236502, 47.5990835 ], [ -122.3235403, 47.5990828 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786836, "project_id": 13, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238831, 47.5990765 ], [ -122.3238734, 47.5987549 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786837, "project_id": 13, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3240559, 47.5990796 ], [ -122.3239314, 47.5990774 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786838, "project_id": 13, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238357, 47.5990691 ], [ -122.3238831, 47.5990765 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786839, "project_id": 13, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239304, 47.5991288 ], [ -122.3239314, 47.5990774 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786840, "project_id": 13, "task_id": 324 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239314, 47.5990774 ], [ -122.3238831, 47.5990765 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786841, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220918, 47.601296 ], [ -122.3217463, 47.6010239 ], [ -122.3216705, 47.6009783 ], [ -122.3216279, 47.6009634 ], [ -122.3215911, 47.6009586 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786842, "project_id": 14, "task_id": 225 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3104009, 47.600895 ], [ -122.3103982, 47.6009249 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786843, "project_id": 14, "task_id": 224 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103472, 47.6009101 ], [ -122.310218, 47.6009109 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786844, "project_id": 13, "task_id": 261 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206072, 47.6035851 ], [ -122.3202174, 47.6035856 ], [ -122.3201859, 47.6035948 ], [ -122.3200974, 47.6035957 ], [ -122.3200503, 47.6035889 ], [ -122.3200161, 47.6035739 ], [ -122.3199986, 47.6035522 ], [ -122.3199893, 47.6035333 ], [ -122.3199872, 47.6035183 ], [ -122.319994, 47.6034966 ], [ -122.3200048, 47.6034815 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786845, "project_id": 13, "task_id": 132 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3198467, 47.6035026 ], [ -122.3199182, 47.6034665 ], [ -122.3199743, 47.6034669 ], [ -122.3200048, 47.6034815 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786846, "project_id": 13, "task_id": 261 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3198467, 47.6035026 ], [ -122.3201304, 47.6037782 ], [ -122.3205567, 47.6041954 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786847, "project_id": 13, "task_id": 261 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3200048, 47.6034815 ], [ -122.3200431, 47.6034636 ], [ -122.320076, 47.6034573 ], [ -122.3201826, 47.6034555 ], [ -122.3202209, 47.6034579 ], [ -122.3202787, 47.6034657 ], [ -122.320605, 47.6034673 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786848, "project_id": 13, "task_id": 191 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214508, 47.6011351 ], [ -122.3215384, 47.6012747 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786849, "project_id": 13, "task_id": 191 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3215911, 47.6009586 ], [ -122.3215481, 47.6009645 ], [ -122.3215102, 47.6009802 ], [ -122.3214711, 47.6010046 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786850, "project_id": 13, "task_id": 191 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214711, 47.6010046 ], [ -122.3214582, 47.6010542 ], [ -122.3214508, 47.6011351 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786851, "project_id": 13, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214711, 47.6010046 ], [ -122.321413, 47.6010219 ], [ -122.3213244, 47.6010163 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786852, "project_id": 13, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214508, 47.6011351 ], [ -122.3214118, 47.6010908 ], [ -122.3213244, 47.6010163 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786853, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322304, 47.5975938 ], [ -122.3217328, 47.5975955 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786854, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223478, 47.5974078 ], [ -122.3223508, 47.5969659 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786855, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223072, 47.5974366 ], [ -122.3216636, 47.5974405 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786856, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322578, 47.5982669 ], [ -122.3225818, 47.5976193 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786857, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226223, 47.5975923 ], [ -122.322784, 47.5975912 ], [ -122.3235932, 47.5975959 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786858, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223037, 47.59758 ], [ -122.322307, 47.5974482 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786859, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3223725, 47.5974085 ], [ -122.3225636, 47.5973971 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786860, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225636, 47.5973971 ], [ -122.3225808, 47.5973964 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786861, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225807, 47.5974347 ], [ -122.3225808, 47.5973964 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786862, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225937, 47.5974348 ], [ -122.322593, 47.5974492 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786863, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322593, 47.5974492 ], [ -122.3226205, 47.5975825 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786864, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226205, 47.5975825 ], [ -122.3226223, 47.5975923 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786865, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322582, 47.5975925 ], [ -122.3226223, 47.5975923 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786866, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225818, 47.5976193 ], [ -122.322565, 47.5976189 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786867, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322565, 47.5976189 ], [ -122.322367, 47.597616 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786868, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225807, 47.5974347 ], [ -122.3225937, 47.5974348 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786869, "project_id": 13, "task_id": 197 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225818, 47.5976193 ], [ -122.322582, 47.5975925 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786870, "project_id": 13, "task_id": 272 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226061, 47.6019484 ], [ -122.3226341, 47.602311 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786871, "project_id": 14, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114805, 47.6009247 ], [ -122.3103982, 47.6009249 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786872, "project_id": 14, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114822, 47.6007737 ], [ -122.3104007, 47.6007708 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786873, "project_id": 14, "task_id": 111 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3117088, 47.6007783 ], [ -122.3116794, 47.6000956 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786874, "project_id": 14, "task_id": 104 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3144594, 47.5990975 ], [ -122.3143993, 47.5990979 ], [ -122.3143482, 47.599098 ], [ -122.314292, 47.5990925 ], [ -122.3142432, 47.5990824 ], [ -122.3142085, 47.5990718 ], [ -122.3141785, 47.5990595 ], [ -122.3141531, 47.5990478 ], [ -122.3141208, 47.5990323 ], [ -122.3140976, 47.599018 ], [ -122.3140813, 47.5990051 ], [ -122.3140537, 47.5989817 ], [ -122.314029, 47.5989537 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786875, "project_id": 14, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3143482, 47.599098 ], [ -122.3143506, 47.5991203 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786876, "project_id": 14, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142931, 47.5994202 ], [ -122.3142582, 47.5994042 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786877, "project_id": 14, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3139665, 47.5992981 ], [ -122.3139911, 47.599298 ], [ -122.3140014, 47.5992992 ], [ -122.3140106, 47.5993027 ], [ -122.3140209, 47.5993112 ], [ -122.3140255, 47.5993272 ], [ -122.3140257, 47.5993417 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786878, "project_id": 14, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140257, 47.5993417 ], [ -122.31405, 47.5993442 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786879, "project_id": 14, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140257, 47.5993417 ], [ -122.3140209, 47.5994014 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786880, "project_id": 14, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3139665, 47.5992981 ], [ -122.3139662, 47.5992902 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786881, "project_id": 14, "task_id": 104 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3139662, 47.5992902 ], [ -122.3138078, 47.5991211 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786882, "project_id": 14, "task_id": 147 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3141208, 47.5990323 ], [ -122.314106, 47.5990404 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786883, "project_id": 14, "task_id": 104 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314106, 47.5990404 ], [ -122.3138352, 47.5990822 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786884, "project_id": 13, "task_id": 272 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3226341, 47.602311 ], [ -122.32263, 47.6023532 ], [ -122.3226052, 47.6024454 ], [ -122.3225683, 47.6025246 ], [ -122.3225126, 47.6025951 ], [ -122.322461, 47.6026408 ], [ -122.3223932, 47.6026883 ], [ -122.3223228, 47.602739 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786885, "project_id": 14, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314273, 47.6035794 ], [ -122.314317, 47.6035795 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786886, "project_id": 14, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314316, 47.6035536 ], [ -122.314317, 47.6035795 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786887, "project_id": 14, "task_id": 215 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314317, 47.6035795 ], [ -122.3146284, 47.6035781 ], [ -122.315486, 47.603581 ], [ -122.3159488, 47.6035789 ], [ -122.3166521, 47.6035827 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786888, "project_id": 14, "task_id": 311 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316626, 47.6035574 ], [ -122.3166521, 47.6035827 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786889, "project_id": 14, "task_id": 311 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316682, 47.6035826 ], [ -122.3166521, 47.6035827 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786890, "project_id": 14, "task_id": 311 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166273, 47.6034582 ], [ -122.316628, 47.6034802 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786891, "project_id": 14, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166651, 47.6034481 ], [ -122.3166525, 47.6027628 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786892, "project_id": 14, "task_id": 311 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316673, 47.6034617 ], [ -122.3166651, 47.6034481 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786893, "project_id": 14, "task_id": 311 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166273, 47.6034582 ], [ -122.3166651, 47.6034481 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786894, "project_id": 14, "task_id": 311 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316914, 47.6035803 ], [ -122.3169437, 47.6035807 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786895, "project_id": 14, "task_id": 311 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169433, 47.6035615 ], [ -122.3169437, 47.6035807 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786896, "project_id": 14, "task_id": 311 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316945, 47.603474 ], [ -122.3169468, 47.6034565 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786897, "project_id": 14, "task_id": 311 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31692, 47.6034564 ], [ -122.3169468, 47.6034565 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786898, "project_id": 14, "task_id": 130 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129956, 47.6044154 ], [ -122.3129881, 47.6051342 ], [ -122.312986, 47.6052749 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786899, "project_id": 14, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.312773, 47.6052726 ], [ -122.3127818, 47.6044799 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786900, "project_id": 14, "task_id": 130 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129521, 47.6044154 ], [ -122.3128253, 47.6044153 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786901, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206048, 47.6034505 ], [ -122.3206287, 47.6032052 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786902, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206072, 47.6035851 ], [ -122.3206163, 47.6035853 ], [ -122.3206131, 47.6038809 ], [ -122.320621, 47.6041891 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786903, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209033, 47.6035839 ], [ -122.3208491, 47.6035827 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786904, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209026, 47.6034467 ], [ -122.3209018, 47.6034021 ], [ -122.320901, 47.6031941 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786905, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209026, 47.6034467 ], [ -122.3208399, 47.6034467 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786906, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209033, 47.6035839 ], [ -122.3209026, 47.6034467 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786907, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320605, 47.6034673 ], [ -122.3206051, 47.6034899 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786908, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206474, 47.6034501 ], [ -122.3206048, 47.6034505 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786909, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.320605, 47.6034673 ], [ -122.3206048, 47.6034505 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786910, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208399, 47.6034467 ], [ -122.3206474, 47.6034501 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786911, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206163, 47.6035853 ], [ -122.32065, 47.6035828 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786912, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206072, 47.6035851 ], [ -122.3206078, 47.6035615 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786913, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206078, 47.6035615 ], [ -122.3206051, 47.6034899 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786914, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.32065, 47.6035828 ], [ -122.3208491, 47.6035827 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786915, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3211804, 47.6034128 ], [ -122.3210995, 47.6033718 ], [ -122.3210531, 47.6033422 ], [ -122.3210294, 47.6033266 ], [ -122.3209709, 47.603269 ], [ -122.320901, 47.6031941 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786916, "project_id": 14, "task_id": 225 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3104009, 47.600895 ], [ -122.3103976, 47.600802 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786917, "project_id": 14, "task_id": 225 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103976, 47.600802 ], [ -122.3104007, 47.6007708 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786918, "project_id": 14, "task_id": 223 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3104007, 47.6007708 ], [ -122.3104, 47.6001032 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786919, "project_id": 14, "task_id": 225 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3104007, 47.6007708 ], [ -122.310343, 47.6007707 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786920, "project_id": 14, "task_id": 229 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.310343, 47.6007707 ], [ -122.310227, 47.6007709 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786921, "project_id": 14, "task_id": 217 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129966, 47.6043132 ], [ -122.3129954, 47.6043866 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786922, "project_id": 14, "task_id": 217 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129956, 47.6044154 ], [ -122.3129521, 47.6044154 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786923, "project_id": 14, "task_id": 217 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129976, 47.6042846 ], [ -122.3129966, 47.6043132 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786924, "project_id": 14, "task_id": 129 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129552, 47.6042847 ], [ -122.3128171, 47.6042851 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786925, "project_id": 14, "task_id": 217 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129976, 47.6042846 ], [ -122.3129552, 47.6042847 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786926, "project_id": 14, "task_id": 217 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129954, 47.6043866 ], [ -122.3129956, 47.6044154 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786927, "project_id": 14, "task_id": 217 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129956, 47.6044154 ], [ -122.3135385, 47.6044165 ], [ -122.3140827, 47.6044161 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786928, "project_id": 13, "task_id": 274 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209043, 47.6027965 ], [ -122.3209031, 47.6027754 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786929, "project_id": 13, "task_id": 274 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209031, 47.6027754 ], [ -122.3214655, 47.6027802 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786930, "project_id": 13, "task_id": 274 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206192, 47.6027585 ], [ -122.3206383, 47.602789 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786931, "project_id": 13, "task_id": 275 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208983, 47.6022059 ], [ -122.3209014, 47.6026216 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786932, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323671, 47.5976178 ], [ -122.3236509, 47.5976179 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786933, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235932, 47.5975959 ], [ -122.3236504, 47.5975969 ], [ -122.3236509, 47.5976179 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786934, "project_id": 13, "task_id": 315 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323594, 47.5975828 ], [ -122.3235932, 47.5975959 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786937, "project_id": 14, "task_id": 224 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3103472, 47.6009101 ], [ -122.3103982, 47.6009249 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786938, "project_id": 14, "task_id": 228 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101792, 47.6008947 ], [ -122.310173, 47.6009241 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786939, "project_id": 14, "task_id": 198 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3088758, 47.5998077 ], [ -122.308883, 47.5993218 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786940, "project_id": 13, "task_id": 447 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3264381, 47.6019156 ], [ -122.3264407, 47.6019742 ], [ -122.3264534, 47.6020465 ], [ -122.3264747, 47.6021079 ], [ -122.3265042, 47.6021733 ], [ -122.3265443, 47.6022367 ], [ -122.3265835, 47.6022922 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786941, "project_id": 13, "task_id": 447 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3263352, 47.6019307 ], [ -122.3263383, 47.601981 ], [ -122.326349, 47.6020415 ], [ -122.3263677, 47.6021072 ], [ -122.326394, 47.6021706 ], [ -122.3264214, 47.6022198 ], [ -122.3264635, 47.6022808 ], [ -122.3265105, 47.6023475 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786942, "project_id": 13, "task_id": 447 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265105, 47.6023475 ], [ -122.3266005, 47.6024662 ], [ -122.3266909, 47.6025874 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786943, "project_id": 13, "task_id": 448 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3265835, 47.6022922 ], [ -122.3266699, 47.6024082 ], [ -122.3267876, 47.6025692 ], [ -122.3268814, 47.6026961 ], [ -122.3270437, 47.6028814 ], [ -122.3272735, 47.6031385 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786944, "project_id": 13, "task_id": 448 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3271499, 47.6032546 ], [ -122.326966, 47.6030519 ], [ -122.3268434, 47.6029181 ], [ -122.3267278, 47.6028055 ], [ -122.3266297, 47.6027205 ], [ -122.3264126, 47.6025567 ], [ -122.3262994, 47.6024857 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786945, "project_id": 14, "task_id": 104 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3136489, 47.5988648 ], [ -122.3138011, 47.5990544 ], [ -122.3138117, 47.5990735 ], [ -122.3138147, 47.5990829 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786946, "project_id": 14, "task_id": 104 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3138147, 47.5990829 ], [ -122.3138352, 47.5990822 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786947, "project_id": 14, "task_id": 104 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3138147, 47.5990829 ], [ -122.3138137, 47.5990961 ], [ -122.3138035, 47.5991129 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786948, "project_id": 14, "task_id": 104 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3138035, 47.5991129 ], [ -122.3137847, 47.599126 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786949, "project_id": 14, "task_id": 104 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3138035, 47.5991129 ], [ -122.3138078, 47.5991211 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786950, "project_id": 14, "task_id": 258 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140888, 47.6042879 ], [ -122.314089, 47.6043148 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786951, "project_id": 14, "task_id": 258 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3141492, 47.604277 ], [ -122.3140888, 47.6042879 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786952, "project_id": 14, "task_id": 223 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101683, 47.6007702 ], [ -122.3101733, 47.6001053 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786954, "project_id": 14, "task_id": 148 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142947, 47.6000924 ], [ -122.314295, 47.6000809 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786955, "project_id": 14, "task_id": 148 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142892, 47.600101 ], [ -122.314257, 47.6000912 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786956, "project_id": 13, "task_id": 326 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251928, 47.5984413 ], [ -122.3251778, 47.598767 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786962, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238734, 47.5987549 ], [ -122.3238777, 47.5984684 ], [ -122.3238782, 47.5984329 ], [ -122.3239243, 47.5984323 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786963, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3239243, 47.5984323 ], [ -122.3239238, 47.5984223 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786964, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238777, 47.5984684 ], [ -122.3238663, 47.5984684 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786965, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323651, 47.598752 ], [ -122.3236515, 47.5984684 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786966, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238663, 47.5984684 ], [ -122.3236683, 47.5984683 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786967, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235971, 47.5984198 ], [ -122.3235946, 47.5982914 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786970, "project_id": 13, "task_id": 358 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251575, 47.6037391 ], [ -122.3255049, 47.6041192 ], [ -122.3255231, 47.6041433 ], [ -122.3255346, 47.6041713 ], [ -122.3255377, 47.6042062 ], [ -122.3255348, 47.6042276 ], [ -122.3255216, 47.6042568 ], [ -122.3254957, 47.6042835 ], [ -122.3254561, 47.6043093 ], [ -122.3253117, 47.6043821 ], [ -122.3253044, 47.6043888 ], [ -122.3253054, 47.6044006 ], [ -122.3253091, 47.6044391 ], [ -122.3253028, 47.6044635 ], [ -122.3250967, 47.6045589 ], [ -122.3250541, 47.6045624 ], [ -122.3249814, 47.6045688 ], [ -122.3248222, 47.6046413 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786971, "project_id": 13, "task_id": 358 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249218, 47.6037481 ], [ -122.325286, 47.6041479 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786972, "project_id": 13, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249984, 47.6026041 ], [ -122.3255021, 47.6030178 ], [ -122.3256481, 47.6031502 ], [ -122.3258801, 47.6033882 ], [ -122.326055, 47.6035703 ], [ -122.3261875, 47.6037371 ], [ -122.3263237, 47.6039915 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786973, "project_id": 14, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169341, 47.6027507 ], [ -122.3169308, 47.6031014 ], [ -122.3169468, 47.6034565 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786974, "project_id": 14, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169341, 47.6027507 ], [ -122.3169109, 47.6027522 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786975, "project_id": 13, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3213244, 47.6010163 ], [ -122.3212034, 47.6009621 ], [ -122.3211427, 47.6009424 ], [ -122.3210873, 47.6009376 ], [ -122.3208826, 47.6009365 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786976, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206383, 47.602789 ], [ -122.320634, 47.6029092 ], [ -122.3206287, 47.6032052 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786977, "project_id": 13, "task_id": 274 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209043, 47.6027965 ], [ -122.320901, 47.6031941 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786978, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322529, 47.5984401 ], [ -122.322377, 47.5984541 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786979, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322341, 47.5984045 ], [ -122.322337, 47.5983054 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786980, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322587, 47.5984045 ], [ -122.322578, 47.5982966 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786981, "project_id": 13, "task_id": 196 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.322543, 47.5982668 ], [ -122.322388, 47.5982726 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786983, "project_id": 14, "task_id": 331 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155822, 47.6067911 ], [ -122.3155863, 47.6067866 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786986, "project_id": 14, "task_id": 331 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155837, 47.6068822 ], [ -122.3155916, 47.6068881 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786987, "project_id": 14, "task_id": 148 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142947, 47.6000924 ], [ -122.3142902, 47.600096 ], [ -122.3142892, 47.600101 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786988, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220435, 47.6027762 ], [ -122.3214655, 47.6027802 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786989, "project_id": 13, "task_id": 188 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225766, 47.5990718 ], [ -122.322745, 47.5990726 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786990, "project_id": 13, "task_id": 195 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3225708, 47.5992771 ], [ -122.3225726, 47.5992928 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786991, "project_id": 13, "task_id": 85 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235013, 47.599307 ], [ -122.3225726, 47.5992928 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786992, "project_id": 13, "task_id": 85 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235403, 47.5990828 ], [ -122.3231875, 47.5990827 ], [ -122.322745, 47.5990726 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786993, "project_id": 14, "task_id": 105 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3137847, 47.599126 ], [ -122.31377, 47.5991322 ], [ -122.3137529, 47.5991356 ], [ -122.3125499, 47.5991461 ], [ -122.3117026, 47.5991466 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786994, "project_id": 14, "task_id": 205 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101518, 47.5982555 ], [ -122.3099201, 47.5982561 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786995, "project_id": 14, "task_id": 205 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101552, 47.598399 ], [ -122.3099099, 47.5983975 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786996, "project_id": 14, "task_id": 205 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3099201, 47.5982561 ], [ -122.3093514, 47.5982559 ], [ -122.3089273, 47.5982553 ], [ -122.3085463, 47.5982541 ], [ -122.3080411, 47.5982524 ], [ -122.3075443, 47.598253 ], [ -122.3069825, 47.5982524 ], [ -122.3064717, 47.5982507 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786997, "project_id": 14, "task_id": 182 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3117049, 47.5982624 ], [ -122.3120733, 47.5982662 ], [ -122.3123065, 47.5982666 ], [ -122.3130082, 47.5982635 ], [ -122.3132051, 47.5982641 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786998, "project_id": 14, "task_id": 182 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3133141, 47.5984098 ], [ -122.3117004, 47.5984034 ] ] } }, +{ "type": "Feature", "properties": { "id": 1786999, "project_id": 14, "task_id": 205 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3099099, 47.5983975 ], [ -122.309468, 47.5983957 ], [ -122.3086847, 47.5983969 ], [ -122.3080595, 47.5983952 ], [ -122.3072484, 47.598394 ], [ -122.3064892, 47.5983924 ], [ -122.3064664, 47.5984007 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787004, "project_id": 13, "task_id": 46 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208826, 47.6009365 ], [ -122.3205362, 47.6009362 ], [ -122.3200577, 47.6009357 ], [ -122.3198277, 47.600936 ], [ -122.3197739, 47.6009381 ], [ -122.3197257, 47.600942 ], [ -122.3196778, 47.6009482 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787005, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3199945, 47.600772 ], [ -122.3205147, 47.600775 ], [ -122.3205356, 47.6007751 ], [ -122.3205806, 47.6007754 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787029, "project_id": 14, "task_id": 98 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129455, 47.5999364 ], [ -122.3129455, 47.5999693 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787030, "project_id": 14, "task_id": 98 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.312942, 47.6000898 ], [ -122.3129446, 47.6000582 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787031, "project_id": 14, "task_id": 98 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129446, 47.6000582 ], [ -122.3129455, 47.5999693 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787048, "project_id": 14, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3075379, 47.6060815 ], [ -122.3064535, 47.60607 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787185, "project_id": 14, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173671, 47.5975964 ], [ -122.317345, 47.5975953 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787186, "project_id": 14, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317146, 47.5975836 ], [ -122.3171221, 47.5975817 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787235, "project_id": 14, "task_id": 185 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3136299, 47.5984167 ], [ -122.3136316, 47.5983924 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787237, "project_id": 14, "task_id": 185 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3136299, 47.5984167 ], [ -122.3136136, 47.5984146 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787239, "project_id": 14, "task_id": 181 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3133141, 47.5984098 ], [ -122.3133358, 47.598396 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787240, "project_id": 13, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209091, 47.6048715 ], [ -122.3209159, 47.6048634 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787249, "project_id": 14, "task_id": 185 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3136316, 47.5983924 ], [ -122.3135564, 47.5982955 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787250, "project_id": 14, "task_id": 185 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3135382, 47.5982553 ], [ -122.3135564, 47.5982955 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787251, "project_id": 14, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182331, 47.602734 ], [ -122.318215, 47.6026556 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787252, "project_id": 14, "task_id": 264 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.318034, 47.6027425 ], [ -122.3181864, 47.6027574 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787253, "project_id": 14, "task_id": 264 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.318034, 47.6027425 ], [ -122.3180553, 47.6026545 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787254, "project_id": 14, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3181864, 47.6027574 ], [ -122.3182253, 47.6027547 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787255, "project_id": 14, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182331, 47.602734 ], [ -122.3182253, 47.6027547 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787256, "project_id": 13, "task_id": 138 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182253, 47.6027547 ], [ -122.3185602, 47.6027548 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787257, "project_id": 13, "task_id": 138 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3185786, 47.6026297 ], [ -122.3182139, 47.6026284 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787258, "project_id": 14, "task_id": 264 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180553, 47.6026545 ], [ -122.3180589, 47.6026281 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787259, "project_id": 14, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.318215, 47.6026556 ], [ -122.3182139, 47.6026284 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787260, "project_id": 14, "task_id": 263 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3182139, 47.6026284 ], [ -122.3180589, 47.6026281 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787261, "project_id": 14, "task_id": 264 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180589, 47.6026281 ], [ -122.317922, 47.6026277 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787262, "project_id": 14, "task_id": 264 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.318034, 47.6027425 ], [ -122.3180196, 47.6027561 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787263, "project_id": 14, "task_id": 264 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3180196, 47.6027561 ], [ -122.3177781, 47.6027531 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787264, "project_id": 14, "task_id": 264 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317922, 47.6026277 ], [ -122.3177688, 47.6026267 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787265, "project_id": 14, "task_id": 185 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3132308, 47.5982637 ], [ -122.3134964, 47.5982666 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787266, "project_id": 14, "task_id": 185 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3134964, 47.5982666 ], [ -122.3135382, 47.5982553 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787267, "project_id": 14, "task_id": 181 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3132051, 47.5982641 ], [ -122.3132308, 47.5982637 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787268, "project_id": 14, "task_id": 181 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3132051, 47.5982641 ], [ -122.3132136, 47.5982856 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787269, "project_id": 14, "task_id": 181 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3133141, 47.5984098 ], [ -122.3132844, 47.5983687 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787270, "project_id": 14, "task_id": 181 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3132844, 47.5983687 ], [ -122.3132136, 47.5982856 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787271, "project_id": 14, "task_id": 100 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3135382, 47.5982553 ], [ -122.313515, 47.5982449 ], [ -122.3130387, 47.5976302 ], [ -122.3130232, 47.5976097 ], [ -122.313018, 47.5976004 ], [ -122.3130205, 47.5975901 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787272, "project_id": 14, "task_id": 39 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3132051, 47.5982641 ], [ -122.3126736, 47.5975726 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787273, "project_id": 14, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3143049, 47.6055225 ], [ -122.314305, 47.605509 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787274, "project_id": 14, "task_id": 333 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314305, 47.605509 ], [ -122.3142654, 47.6055084 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787275, "project_id": 14, "task_id": 193 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3117026, 47.5991466 ], [ -122.3117021, 47.599021 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787278, "project_id": 14, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3177688, 47.6026267 ], [ -122.3171305, 47.6026299 ], [ -122.316944, 47.6026295 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787279, "project_id": 14, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3177781, 47.6027531 ], [ -122.3169473, 47.6027511 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787280, "project_id": 14, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169474, 47.6043189 ], [ -122.3169271, 47.6043919 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787281, "project_id": 14, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3168859, 47.6042784 ], [ -122.3166736, 47.6042724 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787282, "project_id": 14, "task_id": 330 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3168862, 47.6044313 ], [ -122.3166717, 47.6044165 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787283, "project_id": 14, "task_id": 100 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3130205, 47.5975901 ], [ -122.3129977, 47.5975859 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787290, "project_id": 14, "task_id": 109 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116978, 47.5999345 ], [ -122.3117067, 47.5995737 ], [ -122.311708, 47.599325 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787291, "project_id": 14, "task_id": 109 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114767, 47.5999347 ], [ -122.3114847, 47.599323 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787292, "project_id": 13, "task_id": 141 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.324308, 47.6031638 ], [ -122.32452, 47.6033933 ], [ -122.324578, 47.6034614 ], [ -122.3245796, 47.6034827 ], [ -122.3245773, 47.6035159 ], [ -122.3245803, 47.6035341 ], [ -122.3245904, 47.6035502 ], [ -122.3247344, 47.6037041 ], [ -122.3247539, 47.6037167 ], [ -122.3248052, 47.6037298 ], [ -122.3248955, 47.6037406 ], [ -122.3249218, 47.6037481 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787293, "project_id": 13, "task_id": 144 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251575, 47.6037391 ], [ -122.3251322, 47.6037178 ], [ -122.3250947, 47.6036975 ], [ -122.3250122, 47.6036477 ], [ -122.3250048, 47.6036369 ], [ -122.3248564, 47.6034572 ], [ -122.3248179, 47.6034213 ], [ -122.3247994, 47.603411 ], [ -122.3247616, 47.603398 ], [ -122.3246803, 47.6033819 ], [ -122.3246563, 47.6033752 ], [ -122.3246289, 47.6033626 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787294, "project_id": 14, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155892, 47.6073814 ], [ -122.3161373, 47.6073825 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787295, "project_id": 14, "task_id": 280 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3156153, 47.6074909 ], [ -122.3160404, 47.6074904 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787296, "project_id": 14, "task_id": 334 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155935, 47.6056198 ], [ -122.3155721, 47.6056211 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787297, "project_id": 14, "task_id": 334 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3154125, 47.6056212 ], [ -122.3153841, 47.6056263 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787298, "project_id": 14, "task_id": 334 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155935, 47.6056198 ], [ -122.3155888, 47.6060435 ], [ -122.3155921, 47.606108 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787299, "project_id": 14, "task_id": 334 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3153786, 47.6061114 ], [ -122.3153841, 47.6056263 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787300, "project_id": 14, "task_id": 334 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3155935, 47.6056198 ], [ -122.3158927, 47.6056171 ], [ -122.3165459, 47.6056144 ], [ -122.3166125, 47.6056144 ], [ -122.3166465, 47.6056215 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787301, "project_id": 13, "task_id": 144 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3251575, 47.6037391 ], [ -122.3251065, 47.6036924 ], [ -122.3250244, 47.6036406 ], [ -122.3248475, 47.6034421 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787302, "project_id": 13, "task_id": 358 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3249218, 47.6037481 ], [ -122.3247553, 47.6037147 ], [ -122.3246864, 47.6036435 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787303, "project_id": 14, "task_id": 39 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3126736, 47.5975726 ], [ -122.311704, 47.5975726 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787304, "project_id": 14, "task_id": 39 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3125394, 47.5974203 ], [ -122.3116941, 47.5974156 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787305, "project_id": 14, "task_id": 39 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3125394, 47.5974203 ], [ -122.312564, 47.5974316 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787306, "project_id": 14, "task_id": 39 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3128686, 47.5974306 ], [ -122.3129977, 47.5975859 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787307, "project_id": 14, "task_id": 39 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31258, 47.5974113 ], [ -122.3125394, 47.5974203 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787308, "project_id": 14, "task_id": 236 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3170622, 47.5999416 ], [ -122.3170451, 47.5999456 ], [ -122.3165645, 47.5999451 ], [ -122.3165259, 47.599945 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787309, "project_id": 14, "task_id": 411 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173465, 47.5999751 ], [ -122.3173438, 47.5999828 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787310, "project_id": 14, "task_id": 411 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3170622, 47.5999416 ], [ -122.317075, 47.59995 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787311, "project_id": 14, "task_id": 411 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173508, 47.6001247 ], [ -122.317355, 47.6004991 ], [ -122.3173539, 47.6005971 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787312, "project_id": 14, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317351, 47.6008483 ], [ -122.3173515, 47.6010727 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787313, "project_id": 14, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317351, 47.6008483 ], [ -122.3171876, 47.6008974 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787314, "project_id": 14, "task_id": 411 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173508, 47.6001247 ], [ -122.3173193, 47.6001209 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787315, "project_id": 14, "task_id": 411 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173678, 47.6001017 ], [ -122.3173625, 47.600076 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787316, "project_id": 14, "task_id": 411 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173625, 47.600076 ], [ -122.3173438, 47.5999828 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787317, "project_id": 14, "task_id": 411 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173193, 47.6001209 ], [ -122.3170781, 47.6000954 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787318, "project_id": 14, "task_id": 411 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3170781, 47.6000954 ], [ -122.317075, 47.59995 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787319, "project_id": 14, "task_id": 410 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3181915, 47.600104 ], [ -122.3173678, 47.6001017 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787320, "project_id": 14, "task_id": 411 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173678, 47.6001017 ], [ -122.3173509, 47.6001016 ], [ -122.3173508, 47.6001247 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787321, "project_id": 14, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169437, 47.6027307 ], [ -122.3169473, 47.6027511 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787322, "project_id": 14, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169473, 47.6027511 ], [ -122.3169341, 47.6027507 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787323, "project_id": 14, "task_id": 309 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166525, 47.6027628 ], [ -122.3166379, 47.6027519 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787324, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.312759, 47.6081258 ], [ -122.3127605, 47.6085185 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787325, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.312759, 47.6080952 ], [ -122.312749, 47.6079738 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787326, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3127982, 47.6079519 ], [ -122.3129305, 47.6079507 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787327, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129667, 47.6079716 ], [ -122.3129682, 47.6081007 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787328, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129683, 47.6081235 ], [ -122.3129653, 47.608521 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787329, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.312797, 47.608124 ], [ -122.3129276, 47.6081235 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787330, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129683, 47.6081235 ], [ -122.3129276, 47.6081235 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787331, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129682, 47.6081007 ], [ -122.3129684, 47.6081122 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787332, "project_id": 14, "task_id": 117 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129684, 47.6081122 ], [ -122.3129683, 47.6081235 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787333, "project_id": 14, "task_id": 49 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140269, 47.6091486 ], [ -122.3129435, 47.6091437 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787334, "project_id": 14, "task_id": 119 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3129435, 47.6091437 ], [ -122.3127508, 47.6091415 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787340, "project_id": 14, "task_id": 193 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3117021, 47.599021 ], [ -122.3117025, 47.5988631 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787345, "project_id": 14, "task_id": 235 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3175034, 47.60152 ], [ -122.3171942, 47.6012198 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787346, "project_id": 14, "task_id": 412 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3170781, 47.6000954 ], [ -122.3170644, 47.6001019 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787347, "project_id": 14, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3170644, 47.6001019 ], [ -122.3170735, 47.6001131 ], [ -122.3170747, 47.6001256 ], [ -122.3170719, 47.6001713 ], [ -122.3170497, 47.600264 ], [ -122.3170246, 47.6003394 ], [ -122.316903, 47.6006364 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787348, "project_id": 14, "task_id": 236 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3170644, 47.6001019 ], [ -122.317049, 47.6000951 ], [ -122.3170186, 47.6000927 ], [ -122.3165355, 47.6000955 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787349, "project_id": 14, "task_id": 392 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169356, 47.6051566 ], [ -122.3169403, 47.6051331 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787350, "project_id": 14, "task_id": 392 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169403, 47.6051331 ], [ -122.3169091, 47.6051345 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787351, "project_id": 14, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142632, 47.6062941 ], [ -122.3140995, 47.6062914 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787352, "project_id": 14, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142931, 47.6062706 ], [ -122.3142928, 47.6061294 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787353, "project_id": 14, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140685, 47.6061245 ], [ -122.3140649, 47.6062699 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787354, "project_id": 14, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140915, 47.6061083 ], [ -122.3142539, 47.6061049 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787355, "project_id": 14, "task_id": 398 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3142933, 47.6062858 ], [ -122.314293, 47.6064843 ], [ -122.3142896, 47.6073099 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787356, "project_id": 14, "task_id": 398 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.314062, 47.6073108 ], [ -122.3140644, 47.6064842 ], [ -122.3140661, 47.6062904 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787357, "project_id": 14, "task_id": 394 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3140661, 47.6062904 ], [ -122.3135108, 47.60629 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787358, "project_id": 14, "task_id": 187 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114901, 47.5982848 ], [ -122.3114923, 47.5982638 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787359, "project_id": 14, "task_id": 187 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114901, 47.5982848 ], [ -122.3114939, 47.5983818 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787360, "project_id": 14, "task_id": 187 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114939, 47.5983818 ], [ -122.3114913, 47.5984027 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787361, "project_id": 14, "task_id": 187 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3101518, 47.5982555 ], [ -122.3107685, 47.5982616 ], [ -122.3114923, 47.5982638 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787362, "project_id": 14, "task_id": 187 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114923, 47.5982638 ], [ -122.3115219, 47.5982649 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787363, "project_id": 14, "task_id": 187 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114913, 47.5984027 ], [ -122.3106315, 47.5984001 ], [ -122.3105595, 47.5983982 ], [ -122.3101552, 47.598399 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787364, "project_id": 14, "task_id": 187 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311529, 47.5984008 ], [ -122.3114913, 47.5984027 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787365, "project_id": 14, "task_id": 108 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114913, 47.5984027 ], [ -122.3114881, 47.5988599 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787366, "project_id": 14, "task_id": 187 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114923, 47.5982638 ], [ -122.311491, 47.5975732 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787367, "project_id": 14, "task_id": 187 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116742, 47.5984037 ], [ -122.311529, 47.5984008 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787368, "project_id": 14, "task_id": 187 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3115219, 47.5982649 ], [ -122.311675, 47.5982602 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787369, "project_id": 14, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3176379, 47.6007676 ], [ -122.3173519, 47.6007668 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787370, "project_id": 14, "task_id": 155 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316903, 47.6006364 ], [ -122.3168776, 47.6006183 ], [ -122.3167958, 47.6005405 ], [ -122.3167289, 47.6004796 ], [ -122.3166835, 47.6004393 ], [ -122.3165802, 47.6003526 ], [ -122.316442, 47.6002464 ], [ -122.3162896, 47.6001367 ], [ -122.316232, 47.6000973 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787371, "project_id": 14, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3171523, 47.6008392 ], [ -122.3172302, 47.6005959 ], [ -122.3172439, 47.6005962 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787372, "project_id": 14, "task_id": 413 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3172439, 47.6005962 ], [ -122.3173179, 47.600597 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787373, "project_id": 14, "task_id": 413 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173179, 47.600597 ], [ -122.3173539, 47.6005971 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787374, "project_id": 14, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3171529, 47.6008639 ], [ -122.317125, 47.6008726 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787375, "project_id": 14, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3171523, 47.6008392 ], [ -122.317116, 47.6008356 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787376, "project_id": 14, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3171529, 47.6008639 ], [ -122.3171493, 47.6008523 ], [ -122.3171523, 47.6008392 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787377, "project_id": 14, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173539, 47.6005971 ], [ -122.3173519, 47.6007668 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787378, "project_id": 14, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173519, 47.6007668 ], [ -122.317351, 47.6008483 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787379, "project_id": 14, "task_id": 430 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3166516, 47.6055316 ], [ -122.3166549, 47.6056119 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787393, "project_id": 14, "task_id": 188 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116742, 47.5984037 ], [ -122.3117004, 47.5984034 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787423, "project_id": 14, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3171876, 47.6008974 ], [ -122.3171529, 47.6008639 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787424, "project_id": 14, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316903, 47.6006364 ], [ -122.31693, 47.6006467 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787425, "project_id": 14, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316903, 47.6006364 ], [ -122.3168964, 47.6006522 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787426, "project_id": 14, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3167952, 47.6008567 ], [ -122.3168084, 47.6008318 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787427, "project_id": 14, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3167803, 47.6010098 ], [ -122.3167948, 47.6009642 ], [ -122.3168033, 47.6009209 ], [ -122.316806, 47.6008993 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787428, "project_id": 14, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316806, 47.6008993 ], [ -122.3168364, 47.6009015 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787429, "project_id": 14, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.316806, 47.6008993 ], [ -122.316805, 47.6008852 ], [ -122.3168013, 47.6008698 ], [ -122.3167952, 47.6008567 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787430, "project_id": 14, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3168964, 47.6006522 ], [ -122.3168084, 47.6008318 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787431, "project_id": 14, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3168364, 47.6009015 ], [ -122.3170326, 47.601074 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787432, "project_id": 14, "task_id": 262 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3170326, 47.601074 ], [ -122.3170422, 47.6010802 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787433, "project_id": 14, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.31693, 47.6006467 ], [ -122.317116, 47.6008356 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787434, "project_id": 14, "task_id": 238 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.317125, 47.6008726 ], [ -122.3170326, 47.601074 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787435, "project_id": 14, "task_id": 262 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3171942, 47.6012198 ], [ -122.3170645, 47.6010951 ], [ -122.3170422, 47.6010802 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787439, "project_id": 14, "task_id": 186 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3117049, 47.5982624 ], [ -122.3117021, 47.597925 ], [ -122.311704, 47.5975726 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787440, "project_id": 14, "task_id": 188 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311675, 47.5982602 ], [ -122.3117049, 47.5982624 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787447, "project_id": 14, "task_id": 13 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173607, 47.5966297 ], [ -122.3173657, 47.5974143 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787448, "project_id": 14, "task_id": 13 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3171378, 47.5966213 ], [ -122.3171359, 47.5974236 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787449, "project_id": 14, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195561, 47.5974387 ], [ -122.3173736, 47.5974303 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787507, "project_id": 14, "task_id": 188 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3117004, 47.5984034 ], [ -122.3117019, 47.598386 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787508, "project_id": 14, "task_id": 188 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3117019, 47.598386 ], [ -122.3117053, 47.598285 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787509, "project_id": 14, "task_id": 188 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3117053, 47.598285 ], [ -122.3117049, 47.5982624 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787522, "project_id": 14, "task_id": 277 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311704, 47.5975726 ], [ -122.3116827, 47.597557 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787523, "project_id": 14, "task_id": 277 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116941, 47.5974156 ], [ -122.311681, 47.5974247 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787524, "project_id": 14, "task_id": 279 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3114944, 47.597062 ], [ -122.311499, 47.5974183 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787525, "project_id": 14, "task_id": 278 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311499, 47.5974183 ], [ -122.3115165, 47.5974249 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787526, "project_id": 14, "task_id": 278 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311491, 47.5975732 ], [ -122.3115195, 47.5975583 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787527, "project_id": 14, "task_id": 277 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3116827, 47.597557 ], [ -122.311681, 47.5974247 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787528, "project_id": 14, "task_id": 277 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311681, 47.5974247 ], [ -122.3115165, 47.5974249 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787529, "project_id": 14, "task_id": 278 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3115165, 47.5974249 ], [ -122.3115195, 47.5975583 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787530, "project_id": 14, "task_id": 277 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3115195, 47.5975583 ], [ -122.3116827, 47.597557 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787531, "project_id": 14, "task_id": 278 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311491, 47.5975732 ], [ -122.3107589, 47.5975713 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787532, "project_id": 14, "task_id": 278 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.311499, 47.5974183 ], [ -122.3106643, 47.5974232 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787800, "project_id": 14, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169682, 47.6061344 ], [ -122.3169674, 47.6061468 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787801, "project_id": 14, "task_id": 390 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3169112, 47.6061282 ], [ -122.3169343, 47.6061141 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787802, "project_id": 14, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173722, 47.5975742 ], [ -122.3173749, 47.5974551 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787803, "project_id": 14, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173443, 47.5974155 ], [ -122.3171497, 47.5974238 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787804, "project_id": 14, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3171197, 47.597451 ], [ -122.3171152, 47.5975484 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787805, "project_id": 14, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3171152, 47.5975484 ], [ -122.3171221, 47.5975817 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787806, "project_id": 14, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173777, 47.5975871 ], [ -122.3173671, 47.5975964 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787807, "project_id": 14, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173722, 47.5975742 ], [ -122.3173777, 47.5975871 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787808, "project_id": 14, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173657, 47.5974143 ], [ -122.3173736, 47.5974303 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787809, "project_id": 14, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173736, 47.5974303 ], [ -122.3173749, 47.5974551 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787810, "project_id": 14, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3173657, 47.5974143 ], [ -122.3173443, 47.5974155 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787811, "project_id": 14, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3171359, 47.5974236 ], [ -122.3171191, 47.5974388 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787812, "project_id": 14, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3171497, 47.5974238 ], [ -122.3171359, 47.5974236 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787813, "project_id": 14, "task_id": 16 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3171191, 47.5974388 ], [ -122.3171197, 47.597451 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787865, "project_id": 14, "task_id": 372 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3143957, 47.6016048 ], [ -122.3143585, 47.6015917 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787866, "project_id": 14, "task_id": 374 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3148689, 47.6016116 ], [ -122.3147435, 47.6016116 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787867, "project_id": 14, "task_id": 372 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3144073, 47.6017489 ], [ -122.3142719, 47.6017589 ] ] } }, +{ "type": "Feature", "properties": { "id": 1787939, "project_id": 14, "task_id": 307 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3150333, 47.6017463 ], [ -122.3148831, 47.6017473 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789246, "project_id": 13, "task_id": 143 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3236832, 47.6017867 ], [ -122.3232573, 47.6017916 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789247, "project_id": 13, "task_id": 15 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323893, 47.5999571 ], [ -122.3238806, 47.5999608 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789350, "project_id": 13, "task_id": 191 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3214045, 47.6012763 ], [ -122.3213537, 47.6012329 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789351, "project_id": 13, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3213537, 47.6012329 ], [ -122.321248, 47.6011731 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789352, "project_id": 13, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321248, 47.6011731 ], [ -122.3211146, 47.6011344 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789353, "project_id": 13, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3211146, 47.6011344 ], [ -122.3209642, 47.6011303 ], [ -122.3208933, 47.6011284 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789354, "project_id": 13, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3212614, 47.6013163 ], [ -122.3212085, 47.601257 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789355, "project_id": 13, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3212085, 47.601257 ], [ -122.3211019, 47.6011801 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789356, "project_id": 13, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3211019, 47.6011801 ], [ -122.3209642, 47.6011303 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789389, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3205147, 47.600775 ], [ -122.3204172, 47.6004348 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789390, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3204172, 47.6004348 ], [ -122.3201729, 47.6003933 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789391, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3201729, 47.6003933 ], [ -122.3201825, 47.600363 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789392, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3201825, 47.600363 ], [ -122.3199686, 47.6003272 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789393, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3205362, 47.6009362 ], [ -122.3205368, 47.6008777 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789394, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3205368, 47.6008777 ], [ -122.3205349, 47.6008097 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789395, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3205349, 47.6008097 ], [ -122.3205356, 47.6007751 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789396, "project_id": 13, "task_id": 45 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208933, 47.6011284 ], [ -122.3206583, 47.6011286 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789397, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3208451, 47.6015806 ], [ -122.3206235, 47.6011273 ], [ -122.3206075, 47.6010923 ], [ -122.3205362, 47.6009362 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789398, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206583, 47.6011286 ], [ -122.3206235, 47.6011273 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789399, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206075, 47.6010923 ], [ -122.3203275, 47.6010951 ] ] } }, +{ "type": "Feature", "properties": { "id": 1789400, "project_id": 13, "task_id": 47 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3203275, 47.6010951 ], [ -122.3200797, 47.6011118 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790373, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3211484, 47.601505 ], [ -122.3209394, 47.6015572 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790374, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3209394, 47.6015572 ], [ -122.3208451, 47.6015806 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790375, "project_id": 13, "task_id": 276 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3212614, 47.6013163 ], [ -122.3212648, 47.6013995 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790376, "project_id": 13, "task_id": 44 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3212648, 47.6013995 ], [ -122.3211484, 47.601505 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790377, "project_id": 13, "task_id": 142 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220167, 47.6014602 ], [ -122.3218192, 47.6014628 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790378, "project_id": 13, "task_id": 276 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218192, 47.6014628 ], [ -122.3216389, 47.6013743 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790379, "project_id": 13, "task_id": 276 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3216389, 47.6013743 ], [ -122.3215384, 47.6012747 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790380, "project_id": 13, "task_id": 276 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218192, 47.6014628 ], [ -122.3216001, 47.6014145 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790381, "project_id": 13, "task_id": 191 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3216001, 47.6014145 ], [ -122.3214857, 47.6013575 ], [ -122.3214045, 47.6012763 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790382, "project_id": 13, "task_id": 276 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3211919, 47.6017853 ], [ -122.3216106, 47.6022765 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790383, "project_id": 13, "task_id": 276 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321687, 47.6022982 ], [ -122.321657, 47.6022656 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790384, "project_id": 13, "task_id": 276 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.321657, 47.6022656 ], [ -122.3216106, 47.6022765 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790419, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3193283, 47.6027463 ], [ -122.3193018, 47.602758 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790420, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319526, 47.6031162 ], [ -122.3195439, 47.6031249 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790421, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3195946, 47.6031126 ], [ -122.319594, 47.6031241 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790422, "project_id": 13, "task_id": 137 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.319594, 47.6031241 ], [ -122.3195439, 47.6031249 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790423, "project_id": 13, "task_id": 134 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3210531, 47.6033422 ], [ -122.3209018, 47.6034021 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790582, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238648, 47.5982426 ], [ -122.3235946, 47.5982914 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790583, "project_id": 13, "task_id": 323 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238648, 47.5982426 ], [ -122.3239238, 47.5984223 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790674, "project_id": 13, "task_id": 15 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3238806, 47.5999608 ], [ -122.3236572, 47.5999591 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790686, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3221707, 47.6025984 ], [ -122.3220802, 47.602631 ], [ -122.3219729, 47.6025144 ], [ -122.3219625, 47.6025031 ], [ -122.3218221, 47.6024702 ], [ -122.3219357, 47.6024137 ], [ -122.321927, 47.6024008 ], [ -122.3217507, 47.602397 ], [ -122.3217327, 47.6024001 ], [ -122.3218033, 47.6024775 ], [ -122.3218504, 47.6025291 ], [ -122.3218864, 47.602536 ], [ -122.3218937, 47.6025435 ], [ -122.3219337, 47.6025846 ], [ -122.3219633, 47.60262 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790687, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219729, 47.6025144 ], [ -122.3218937, 47.6025435 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790688, "project_id": 13, "task_id": 270 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3218221, 47.6024702 ], [ -122.3218033, 47.6024775 ] ] } }, +{ "type": "Feature", "properties": { "id": 1790689, "project_id": 13, "task_id": 276 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3217327, 47.6024001 ], [ -122.321687, 47.6022982 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952344, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3207191, 47.6055466 ], [ -122.3207191, 47.6053731 ], [ -122.3207191, 47.6053615 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952345, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206987, 47.6053716 ], [ -122.3206578, 47.6053716 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952346, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3207191, 47.6053731 ], [ -122.3206987, 47.6053716 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952347, "project_id": 13, "task_id": 268 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3206578, 47.6053716 ], [ -122.3206179, 47.6053707 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952525, "project_id": 13, "task_id": 140 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220401, 47.6041074 ], [ -122.3219142, 47.6039725 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952526, "project_id": 13, "task_id": 140 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3220401, 47.6041074 ], [ -122.3220464, 47.6041164 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952527, "project_id": 13, "task_id": 140 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219142, 47.6039725 ], [ -122.3219052, 47.603963 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952528, "project_id": 13, "task_id": 140 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3219052, 47.603963 ], [ -122.3218631, 47.6039167 ], [ -122.321855, 47.6039077 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952529, "project_id": 13, "task_id": 398 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3235196, 47.6041176 ], [ -122.3234124, 47.6041513 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952530, "project_id": 13, "task_id": 398 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.323549, 47.6041082 ], [ -122.3235196, 47.6041176 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952531, "project_id": 13, "task_id": 398 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3234124, 47.6041513 ], [ -122.323393, 47.6041612 ] ] } }, +{ "type": "Feature", "properties": { "id": 1952955, "project_id": 13, "task_id": 239 }, "geometry": { "type": "LineString", "coordinates": [ [ -122.3275795, 47.6045171 ], [ -122.3271552, 47.6046747 ] ] } } +] +} diff --git a/tests/xnqm/inputs/p14_polygon.geojson b/tests/xnqm/inputs/p14_polygon.geojson new file mode 100755 index 0000000..c00d158 --- /dev/null +++ b/tests/xnqm/inputs/p14_polygon.geojson @@ -0,0 +1,460 @@ +{ +"type": "FeatureCollection", +"name": "p14", +"crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:OGC:1.3:CRS84" } }, +"features": [ +{ "type": "Feature", "properties": { "pk": "1483", "project_id": 14, "task_id": 83, "numnodechanges": 130, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323713, 47.608609 ], [ -122.32372, 47.60861 ], [ -122.32391, 47.608844 ], [ -122.323138, 47.609272 ], [ -122.322387, 47.609542 ], [ -122.32315, 47.608848 ], [ -122.323713, 47.608609 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14164", "project_id": 14, "task_id": 164, "numnodechanges": 223, "numwaychanges": 33 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320401, 47.603958 ], [ -122.320771, 47.604408 ], [ -122.320359, 47.604821 ], [ -122.320312, 47.604791 ], [ -122.320339, 47.603985 ], [ -122.320401, 47.603958 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14288", "project_id": 14, "task_id": 288, "numnodechanges": 179, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310931, 47.601813 ], [ -122.310933, 47.60132 ], [ -122.310968, 47.601269 ], [ -122.312232, 47.601276 ], [ -122.312231, 47.601886 ], [ -122.310945, 47.601896 ], [ -122.310931, 47.601813 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14170", "project_id": 14, "task_id": 170, "numnodechanges": 10, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324736, 47.606998 ], [ -122.324448, 47.606327 ], [ -122.32476, 47.606039 ], [ -122.32497, 47.606016 ], [ -122.325284, 47.606767 ], [ -122.325069, 47.606965 ], [ -122.324736, 47.606998 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14281", "project_id": 14, "task_id": 281, "numnodechanges": 1, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314773, 47.60698 ], [ -122.316129, 47.606995 ], [ -122.316127, 47.607322 ], [ -122.314634, 47.607302 ], [ -122.314773, 47.60698 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14186", "project_id": 14, "task_id": 186, "numnodechanges": 0, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311582, 47.598331 ], [ -122.311396, 47.5981 ], [ -122.311772, 47.598102 ], [ -122.311617, 47.598333 ], [ -122.311582, 47.598331 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14227", "project_id": 14, "task_id": 227, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310146, 47.601289 ], [ -122.310144, 47.601803 ], [ -122.309907, 47.602076 ], [ -122.309872, 47.602093 ], [ -122.309875, 47.601206 ], [ -122.310013, 47.601241 ], [ -122.310146, 47.601289 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14254", "project_id": 14, "task_id": 254, "numnodechanges": 39, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32361, 47.604776 ], [ -122.32393, 47.604767 ], [ -122.32416, 47.605322 ], [ -122.32388, 47.60543 ], [ -122.32361, 47.604776 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14197", "project_id": 14, "task_id": 197, "numnodechanges": 34, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309413, 47.599117 ], [ -122.308434, 47.599109 ], [ -122.308697, 47.598893 ], [ -122.309478, 47.59889 ], [ -122.309413, 47.599117 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14272", "project_id": 14, "task_id": 272, "numnodechanges": 339, "numwaychanges": 23 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3223, 47.606352 ], [ -122.322657, 47.606026 ], [ -122.322855, 47.60649 ], [ -122.322519, 47.606886 ], [ -122.3223, 47.606352 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14246", "project_id": 14, "task_id": 246, "numnodechanges": 129, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322102, 47.602315 ], [ -122.323365, 47.602292 ], [ -122.323391, 47.602347 ], [ -122.323293, 47.602724 ], [ -122.322625, 47.602926 ], [ -122.322102, 47.602315 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14222", "project_id": 14, "task_id": 222, "numnodechanges": 150, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309929, 47.605262 ], [ -122.309614, 47.605154 ], [ -122.309615, 47.604075 ], [ -122.309639, 47.603988 ], [ -122.309855, 47.603964 ], [ -122.31047, 47.603932 ], [ -122.310752, 47.604094 ], [ -122.310747, 47.605248 ], [ -122.309929, 47.605262 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14361", "project_id": 14, "task_id": 361, "numnodechanges": 163, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310958, 47.603948 ], [ -122.310958, 47.603297 ], [ -122.311113, 47.603317 ], [ -122.311259, 47.603521 ], [ -122.310972, 47.603947 ], [ -122.310958, 47.603948 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1474", "project_id": 14, "task_id": 74, "numnodechanges": 9, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325985, 47.60332 ], [ -122.327287, 47.602417 ], [ -122.327618, 47.602835 ], [ -122.326569, 47.603794 ], [ -122.326372, 47.603792 ], [ -122.325985, 47.60332 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14362", "project_id": 14, "task_id": 362, "numnodechanges": 10, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311259, 47.603521 ], [ -122.311288, 47.60352 ], [ -122.311533, 47.603905 ], [ -122.311421, 47.603947 ], [ -122.310972, 47.603947 ], [ -122.311259, 47.603521 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14178", "project_id": 14, "task_id": 178, "numnodechanges": 4, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32356, 47.607202 ], [ -122.324014, 47.607376 ], [ -122.323999, 47.607452 ], [ -122.32375, 47.607679 ], [ -122.323551, 47.6078 ], [ -122.323081, 47.607732 ], [ -122.323296, 47.607443 ], [ -122.32356, 47.607202 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14343", "project_id": 14, "task_id": 343, "numnodechanges": 47, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317627, 47.601919 ], [ -122.318035, 47.601528 ], [ -122.318043, 47.601755 ], [ -122.317954, 47.601862 ], [ -122.317617, 47.602138 ], [ -122.317627, 47.601919 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14319", "project_id": 14, "task_id": 319, "numnodechanges": 143, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32088, 47.603878 ], [ -122.321021, 47.604405 ], [ -122.320771, 47.604408 ], [ -122.320401, 47.603958 ], [ -122.32049, 47.603883 ], [ -122.32088, 47.603878 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "142", "project_id": 14, "task_id": 2, "numnodechanges": 239, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326098, 47.605523 ], [ -122.326533, 47.605129 ], [ -122.326558, 47.605139 ], [ -122.326987, 47.606153 ], [ -122.326756, 47.606444 ], [ -122.326459, 47.606377 ], [ -122.326098, 47.605523 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1481", "project_id": 14, "task_id": 81, "numnodechanges": 265, "numwaychanges": 20 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323999, 47.607452 ], [ -122.324231, 47.608012 ], [ -122.323973, 47.608213 ], [ -122.32375, 47.607679 ], [ -122.323999, 47.607452 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14215", "project_id": 14, "task_id": 215, "numnodechanges": 155, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314638, 47.603942 ], [ -122.313571, 47.603931 ], [ -122.313575, 47.603262 ], [ -122.31464, 47.603263 ], [ -122.314638, 47.603942 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14200", "project_id": 14, "task_id": 200, "numnodechanges": 4, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311172, 47.599646 ], [ -122.311278, 47.599808 ], [ -122.311275, 47.600115 ], [ -122.31122, 47.600296 ], [ -122.311127, 47.600441 ], [ -122.310983, 47.600647 ], [ -122.310971, 47.600656 ], [ -122.31083, 47.600551 ], [ -122.310629, 47.600222 ], [ -122.31063, 47.599798 ], [ -122.310785, 47.599531 ], [ -122.311172, 47.599646 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14404", "project_id": 14, "task_id": 404, "numnodechanges": 3, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312231, 47.602395 ], [ -122.312234, 47.602182 ], [ -122.312261, 47.601981 ], [ -122.313263, 47.601977 ], [ -122.313531, 47.60233 ], [ -122.31353, 47.602394 ], [ -122.313071, 47.602455 ], [ -122.312716, 47.602456 ], [ -122.312231, 47.602395 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14399", "project_id": 14, "task_id": 399, "numnodechanges": 17, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315891, 47.605828 ], [ -122.316153, 47.606009 ], [ -122.316149, 47.60683 ], [ -122.316131, 47.60685 ], [ -122.31596, 47.606692 ], [ -122.315774, 47.606374 ], [ -122.315775, 47.606028 ], [ -122.315891, 47.605828 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14295", "project_id": 14, "task_id": 295, "numnodechanges": 56, "numwaychanges": 12 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313123, 47.6031 ], [ -122.313154, 47.603098 ], [ -122.31351, 47.603099 ], [ -122.313575, 47.603262 ], [ -122.313571, 47.603931 ], [ -122.313568, 47.603935 ], [ -122.313226, 47.603932 ], [ -122.312899, 47.603517 ], [ -122.313123, 47.6031 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14134", "project_id": 14, "task_id": 134, "numnodechanges": 52, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31091, 47.606774 ], [ -122.312203, 47.606785 ], [ -122.312206, 47.606789 ], [ -122.312203, 47.607393 ], [ -122.31217, 47.607426 ], [ -122.311842, 47.607705 ], [ -122.311216, 47.607709 ], [ -122.310614, 47.607094 ], [ -122.31091, 47.606774 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14407", "project_id": 14, "task_id": 407, "numnodechanges": 59, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319146, 47.598757 ], [ -122.319306, 47.598714 ], [ -122.319423, 47.598772 ], [ -122.319424, 47.599706 ], [ -122.319146, 47.59968 ], [ -122.319146, 47.598757 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14112", "project_id": 14, "task_id": 112, "numnodechanges": 8, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314815, 47.608947 ], [ -122.314686, 47.608636 ], [ -122.314818, 47.608363 ], [ -122.315775, 47.608362 ], [ -122.315999, 47.608585 ], [ -122.316021, 47.608664 ], [ -122.315738, 47.608946 ], [ -122.314815, 47.608947 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14233", "project_id": 14, "task_id": 233, "numnodechanges": 230, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314395, 47.599723 ], [ -122.3143, 47.599617 ], [ -122.314499, 47.599216 ], [ -122.314862, 47.599383 ], [ -122.314726, 47.599765 ], [ -122.314395, 47.599723 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1442", "project_id": 14, "task_id": 42, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314962, 47.598766 ], [ -122.31543, 47.598692 ], [ -122.315671, 47.598869 ], [ -122.315055, 47.599349 ], [ -122.314959, 47.598767 ], [ -122.314962, 47.598766 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14302", "project_id": 14, "task_id": 302, "numnodechanges": 17, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315999, 47.608585 ], [ -122.315775, 47.608362 ], [ -122.315777, 47.607775 ], [ -122.316139, 47.607382 ], [ -122.316169, 47.607426 ], [ -122.316166, 47.608375 ], [ -122.315999, 47.608585 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14285", "project_id": 14, "task_id": 285, "numnodechanges": 5, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314627, 47.607311 ], [ -122.313716, 47.60731 ], [ -122.313395, 47.606784 ], [ -122.313481, 47.606487 ], [ -122.314826, 47.606488 ], [ -122.314829, 47.606699 ], [ -122.314773, 47.60698 ], [ -122.314634, 47.607302 ], [ -122.314627, 47.607311 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "149", "project_id": 14, "task_id": 9, "numnodechanges": 267, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324725, 47.598777 ], [ -122.325372, 47.598781 ], [ -122.32537, 47.599443 ], [ -122.32472, 47.599439 ], [ -122.324722, 47.598779 ], [ -122.324725, 47.598777 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1435", "project_id": 14, "task_id": 35, "numnodechanges": 50, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325413, 47.599768 ], [ -122.325492, 47.59961 ], [ -122.326033, 47.599613 ], [ -122.326031, 47.600458 ], [ -122.325497, 47.60087 ], [ -122.325363, 47.60087 ], [ -122.325366, 47.599935 ], [ -122.325413, 47.599768 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1441", "project_id": 14, "task_id": 41, "numnodechanges": 15, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314966, 47.597837 ], [ -122.315297, 47.597645 ], [ -122.315434, 47.597799 ], [ -122.31543, 47.598692 ], [ -122.314962, 47.598766 ], [ -122.314966, 47.597837 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14162", "project_id": 14, "task_id": 162, "numnodechanges": 4, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324065, 47.599947 ], [ -122.322904, 47.599955 ], [ -122.323091, 47.59978 ], [ -122.324098, 47.599799 ], [ -122.324065, 47.599947 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14301", "project_id": 14, "task_id": 301, "numnodechanges": 102, "numwaychanges": 15 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316169, 47.607426 ], [ -122.316139, 47.607382 ], [ -122.31614, 47.607369 ], [ -122.317591, 47.60736 ], [ -122.317423, 47.607817 ], [ -122.316516, 47.607823 ], [ -122.316169, 47.607426 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14356", "project_id": 14, "task_id": 356, "numnodechanges": 20, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321826, 47.606435 ], [ -122.321812, 47.606736 ], [ -122.32135, 47.60677 ], [ -122.321184, 47.60639 ], [ -122.321826, 47.606435 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14177", "project_id": 14, "task_id": 177, "numnodechanges": 46, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323081, 47.607732 ], [ -122.323551, 47.6078 ], [ -122.3238, 47.608395 ], [ -122.32372, 47.60861 ], [ -122.323713, 47.608609 ], [ -122.323047, 47.608104 ], [ -122.322935, 47.607825 ], [ -122.322937, 47.607785 ], [ -122.323081, 47.607732 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14284", "project_id": 14, "task_id": 284, "numnodechanges": 169, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31482, 47.607762 ], [ -122.314818, 47.608363 ], [ -122.314686, 47.608636 ], [ -122.313746, 47.608628 ], [ -122.313513, 47.60846 ], [ -122.313515, 47.607709 ], [ -122.313716, 47.60731 ], [ -122.314627, 47.607311 ], [ -122.31482, 47.607762 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14140", "project_id": 14, "task_id": 140, "numnodechanges": 67, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310178, 47.60352 ], [ -122.309855, 47.603964 ], [ -122.309639, 47.603988 ], [ -122.309576, 47.603824 ], [ -122.309574, 47.60311 ], [ -122.309625, 47.603042 ], [ -122.309875, 47.603068 ], [ -122.310178, 47.60352 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14360", "project_id": 14, "task_id": 360, "numnodechanges": 398, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32135, 47.60677 ], [ -122.321072, 47.607024 ], [ -122.32094, 47.606639 ], [ -122.321092, 47.606357 ], [ -122.321106, 47.606346 ], [ -122.321184, 47.60639 ], [ -122.32135, 47.60677 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14350", "project_id": 14, "task_id": 350, "numnodechanges": 281, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32201, 47.605286 ], [ -122.322216, 47.605777 ], [ -122.3218, 47.606158 ], [ -122.321306, 47.605663 ], [ -122.321303, 47.605645 ], [ -122.321665, 47.605315 ], [ -122.32201, 47.605286 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14335", "project_id": 14, "task_id": 335, "numnodechanges": 86, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31727, 47.606691 ], [ -122.316306, 47.606694 ], [ -122.316504, 47.606379 ], [ -122.317109, 47.606377 ], [ -122.31727, 47.606691 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14250", "project_id": 14, "task_id": 250, "numnodechanges": 240, "numwaychanges": 23 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321496, 47.603135 ], [ -122.321458, 47.602777 ], [ -122.321459, 47.602437 ], [ -122.321895, 47.602179 ], [ -122.322102, 47.602315 ], [ -122.322625, 47.602926 ], [ -122.322132, 47.603374 ], [ -122.321496, 47.603135 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14340", "project_id": 14, "task_id": 340, "numnodechanges": 12, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316581, 47.601584 ], [ -122.316581, 47.60188 ], [ -122.316281, 47.60218 ], [ -122.316237, 47.602174 ], [ -122.316239, 47.601053 ], [ -122.316389, 47.601202 ], [ -122.316532, 47.601458 ], [ -122.316581, 47.601584 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14280", "project_id": 14, "task_id": 280, "numnodechanges": 64, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316127, 47.607322 ], [ -122.31614, 47.607369 ], [ -122.316139, 47.607382 ], [ -122.315777, 47.607775 ], [ -122.31482, 47.607762 ], [ -122.314627, 47.607311 ], [ -122.314634, 47.607302 ], [ -122.316127, 47.607322 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1459", "project_id": 14, "task_id": 59, "numnodechanges": 108, "numwaychanges": 12 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.30913, 47.603769 ], [ -122.308974, 47.603522 ], [ -122.309267, 47.603106 ], [ -122.309574, 47.60311 ], [ -122.309576, 47.603824 ], [ -122.30913, 47.603769 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14359", "project_id": 14, "task_id": 359, "numnodechanges": 14, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321106, 47.606346 ], [ -122.321118, 47.606079 ], [ -122.321306, 47.605663 ], [ -122.3218, 47.606158 ], [ -122.32184, 47.606404 ], [ -122.321826, 47.606435 ], [ -122.321184, 47.60639 ], [ -122.321106, 47.606346 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14187", "project_id": 14, "task_id": 187, "numnodechanges": 145, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31141, 47.598588 ], [ -122.310965, 47.598632 ], [ -122.310741, 47.598549 ], [ -122.310623, 47.598385 ], [ -122.311039, 47.598048 ], [ -122.311396, 47.5981 ], [ -122.311582, 47.598331 ], [ -122.31141, 47.598588 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "144", "project_id": 14, "task_id": 4, "numnodechanges": 207, "numwaychanges": 26 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326031, 47.600458 ], [ -122.326033, 47.599613 ], [ -122.326037, 47.599611 ], [ -122.326386, 47.599613 ], [ -122.326696, 47.600004 ], [ -122.326694, 47.600458 ], [ -122.326031, 47.600458 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14209", "project_id": 14, "task_id": 209, "numnodechanges": 270, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313481, 47.606487 ], [ -122.313395, 47.606784 ], [ -122.312206, 47.606789 ], [ -122.312203, 47.606785 ], [ -122.312211, 47.605275 ], [ -122.312298, 47.605274 ], [ -122.313242, 47.605291 ], [ -122.313431, 47.605694 ], [ -122.313511, 47.606011 ], [ -122.31351, 47.606302 ], [ -122.313481, 47.606487 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14225", "project_id": 14, "task_id": 225, "numnodechanges": 54, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310459, 47.600616 ], [ -122.31083, 47.600551 ], [ -122.310971, 47.600656 ], [ -122.310968, 47.601269 ], [ -122.310933, 47.60132 ], [ -122.310601, 47.601291 ], [ -122.310307, 47.600847 ], [ -122.310459, 47.600616 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14294", "project_id": 14, "task_id": 294, "numnodechanges": 7, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310989, 47.602162 ], [ -122.310925, 47.602129 ], [ -122.310921, 47.602091 ], [ -122.310945, 47.601896 ], [ -122.312231, 47.601886 ], [ -122.312261, 47.601981 ], [ -122.312234, 47.602182 ], [ -122.310989, 47.602162 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14316", "project_id": 14, "task_id": 316, "numnodechanges": 108, "numwaychanges": 21 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320499, 47.603202 ], [ -122.321435, 47.603192 ], [ -122.321266, 47.603649 ], [ -122.32088, 47.603878 ], [ -122.32049, 47.603883 ], [ -122.320499, 47.603202 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "148", "project_id": 14, "task_id": 8, "numnodechanges": 6, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3097, 47.607193 ], [ -122.308222, 47.607221 ], [ -122.308188, 47.607178 ], [ -122.308315, 47.606596 ], [ -122.309355, 47.606602 ], [ -122.309853, 47.607103 ], [ -122.3097, 47.607193 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14405", "project_id": 14, "task_id": 405, "numnodechanges": 379, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318246, 47.600688 ], [ -122.318153, 47.600572 ], [ -122.318146, 47.600498 ], [ -122.318145, 47.600411 ], [ -122.318165, 47.600138 ], [ -122.318447, 47.599806 ], [ -122.318992, 47.599686 ], [ -122.319146, 47.59968 ], [ -122.319424, 47.599706 ], [ -122.319614, 47.599806 ], [ -122.318444, 47.600803 ], [ -122.318246, 47.600688 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14102", "project_id": 14, "task_id": 102, "numnodechanges": 80, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314377, 47.59703 ], [ -122.314936, 47.596672 ], [ -122.315297, 47.597195 ], [ -122.315297, 47.597645 ], [ -122.314966, 47.597837 ], [ -122.314443, 47.598008 ], [ -122.314378, 47.597964 ], [ -122.314377, 47.59703 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1462", "project_id": 14, "task_id": 62, "numnodechanges": 8, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317625, 47.598744 ], [ -122.316711, 47.598743 ], [ -122.316783, 47.59845 ], [ -122.317509, 47.598451 ], [ -122.317625, 47.598744 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14211", "project_id": 14, "task_id": 211, "numnodechanges": 32, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313265, 47.601357 ], [ -122.313055, 47.601272 ], [ -122.313058, 47.600318 ], [ -122.313675, 47.600545 ], [ -122.313673, 47.601155 ], [ -122.313265, 47.601357 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1424", "project_id": 14, "task_id": 24, "numnodechanges": 4, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325775, 47.605582 ], [ -122.326098, 47.605523 ], [ -122.326459, 47.606377 ], [ -122.32597, 47.606505 ], [ -122.325868, 47.606509 ], [ -122.325559, 47.60578 ], [ -122.325775, 47.605582 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14363", "project_id": 14, "task_id": 363, "numnodechanges": 10, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311426, 47.603315 ], [ -122.311288, 47.60352 ], [ -122.311259, 47.603521 ], [ -122.311113, 47.603317 ], [ -122.311426, 47.603315 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14103", "project_id": 14, "task_id": 103, "numnodechanges": 92, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31221, 47.597378 ], [ -122.312695, 47.597843 ], [ -122.312707, 47.597975 ], [ -122.312192, 47.598411 ], [ -122.311981, 47.598069 ], [ -122.311977, 47.597772 ], [ -122.31221, 47.597378 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14269", "project_id": 14, "task_id": 269, "numnodechanges": 108, "numwaychanges": 20 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321588, 47.608315 ], [ -122.320014, 47.608325 ], [ -122.320083, 47.608025 ], [ -122.320135, 47.607998 ], [ -122.321449, 47.607923 ], [ -122.321588, 47.608315 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14251", "project_id": 14, "task_id": 251, "numnodechanges": 232, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322625, 47.602926 ], [ -122.323293, 47.602724 ], [ -122.323689, 47.603663 ], [ -122.323689, 47.60367 ], [ -122.32344, 47.603899 ], [ -122.322444, 47.603916 ], [ -122.322225, 47.603593 ], [ -122.322132, 47.603374 ], [ -122.322625, 47.602926 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14110", "project_id": 14, "task_id": 110, "numnodechanges": 18, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311275, 47.600115 ], [ -122.31243, 47.600093 ], [ -122.312439, 47.600117 ], [ -122.312344, 47.600307 ], [ -122.31122, 47.600296 ], [ -122.311275, 47.600115 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14291", "project_id": 14, "task_id": 291, "numnodechanges": 213, "numwaychanges": 20 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311419, 47.602466 ], [ -122.31142, 47.602917 ], [ -122.310747, 47.602917 ], [ -122.310749, 47.602516 ], [ -122.310925, 47.602129 ], [ -122.310989, 47.602162 ], [ -122.311419, 47.602466 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14324", "project_id": 14, "task_id": 324, "numnodechanges": 85, "numwaychanges": 15 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317779, 47.605708 ], [ -122.317782, 47.604783 ], [ -122.318182, 47.604784 ], [ -122.318192, 47.604786 ], [ -122.318188, 47.605707 ], [ -122.317782, 47.60571 ], [ -122.317779, 47.605708 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1430", "project_id": 14, "task_id": 30, "numnodechanges": 21, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325945, 47.603293 ], [ -122.324715, 47.604413 ], [ -122.324492, 47.604251 ], [ -122.324341, 47.604064 ], [ -122.325423, 47.60274 ], [ -122.325543, 47.602786 ], [ -122.325673, 47.602907 ], [ -122.325945, 47.603293 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14417", "project_id": 14, "task_id": 417, "numnodechanges": 54, "numwaychanges": 16 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321351, 47.601279 ], [ -122.321542, 47.601272 ], [ -122.322015, 47.601366 ], [ -122.322018, 47.601945 ], [ -122.321895, 47.602179 ], [ -122.321459, 47.602437 ], [ -122.321151, 47.602199 ], [ -122.321158, 47.601358 ], [ -122.321351, 47.601279 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14416", "project_id": 14, "task_id": 416, "numnodechanges": 27, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320891, 47.600802 ], [ -122.321357, 47.600795 ], [ -122.321351, 47.601279 ], [ -122.321158, 47.601358 ], [ -122.320885, 47.60122 ], [ -122.320891, 47.600802 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14438", "project_id": 14, "task_id": 438, "numnodechanges": 7, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320353, 47.60308 ], [ -122.320499, 47.603202 ], [ -122.32049, 47.603883 ], [ -122.320401, 47.603958 ], [ -122.320339, 47.603985 ], [ -122.320132, 47.603949 ], [ -122.320143, 47.603116 ], [ -122.320353, 47.60308 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14450", "project_id": 14, "task_id": 450, "numnodechanges": 62, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319381, 47.603955 ], [ -122.318803, 47.603944 ], [ -122.3188, 47.603941 ], [ -122.31881, 47.603286 ], [ -122.318992, 47.603175 ], [ -122.319252, 47.603109 ], [ -122.319705, 47.603144 ], [ -122.319718, 47.603931 ], [ -122.319381, 47.603955 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14217", "project_id": 14, "task_id": 217, "numnodechanges": 35, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313226, 47.603932 ], [ -122.313568, 47.603935 ], [ -122.313561, 47.604955 ], [ -122.313352, 47.60517 ], [ -122.312895, 47.604339 ], [ -122.313187, 47.603934 ], [ -122.313226, 47.603932 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14437", "project_id": 14, "task_id": 437, "numnodechanges": 23, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320419, 47.602788 ], [ -122.321458, 47.602777 ], [ -122.321496, 47.603135 ], [ -122.321435, 47.603192 ], [ -122.320499, 47.603202 ], [ -122.320353, 47.60308 ], [ -122.320419, 47.602788 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1494", "project_id": 14, "task_id": 94, "numnodechanges": 32, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.307376, 47.60309 ], [ -122.307657, 47.602679 ], [ -122.30769, 47.602678 ], [ -122.307955, 47.603091 ], [ -122.307376, 47.60309 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14218", "project_id": 14, "task_id": 218, "numnodechanges": 4, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317527, 47.60859 ], [ -122.317732, 47.608976 ], [ -122.3164, 47.60898 ], [ -122.316307, 47.608831 ], [ -122.3166, 47.608592 ], [ -122.317527, 47.60859 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14406", "project_id": 14, "task_id": 406, "numnodechanges": 402, "numwaychanges": 23 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319424, 47.599706 ], [ -122.319423, 47.598772 ], [ -122.320332, 47.598766 ], [ -122.320331, 47.599883 ], [ -122.320097, 47.600019 ], [ -122.319614, 47.599806 ], [ -122.319424, 47.599706 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14253", "project_id": 14, "task_id": 253, "numnodechanges": 67, "numwaychanges": 22 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32393, 47.604767 ], [ -122.324492, 47.604251 ], [ -122.324715, 47.604413 ], [ -122.324858, 47.60473 ], [ -122.324813, 47.604856 ], [ -122.324316, 47.605308 ], [ -122.32416, 47.605322 ], [ -122.32393, 47.604767 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14366", "project_id": 14, "task_id": 366, "numnodechanges": 16, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311421, 47.603947 ], [ -122.311416, 47.605262 ], [ -122.310917, 47.605341 ], [ -122.310747, 47.605248 ], [ -122.310752, 47.604094 ], [ -122.310958, 47.603948 ], [ -122.310972, 47.603947 ], [ -122.311421, 47.603947 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14303", "project_id": 14, "task_id": 303, "numnodechanges": 429, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316516, 47.607823 ], [ -122.317423, 47.607817 ], [ -122.317423, 47.608154 ], [ -122.316569, 47.608157 ], [ -122.316515, 47.60811 ], [ -122.316516, 47.607823 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14352", "project_id": 14, "task_id": 352, "numnodechanges": 4, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322231, 47.605085 ], [ -122.322573, 47.605046 ], [ -122.322886, 47.605796 ], [ -122.322663, 47.605992 ], [ -122.322216, 47.605777 ], [ -122.32201, 47.605286 ], [ -122.322231, 47.605085 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14378", "project_id": 14, "task_id": 378, "numnodechanges": 174, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314726, 47.599765 ], [ -122.314862, 47.599383 ], [ -122.315054, 47.599357 ], [ -122.31511, 47.59943 ], [ -122.31495, 47.599884 ], [ -122.314726, 47.599765 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14241", "project_id": 14, "task_id": 241, "numnodechanges": 4, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324174, 47.599569 ], [ -122.32331, 47.599563 ], [ -122.32349, 47.599385 ], [ -122.324086, 47.599389 ], [ -122.324174, 47.599569 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14240", "project_id": 14, "task_id": 240, "numnodechanges": 36, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315958, 47.602212 ], [ -122.315886, 47.602182 ], [ -122.315887, 47.600862 ], [ -122.315897, 47.600859 ], [ -122.316101, 47.600839 ], [ -122.316239, 47.601053 ], [ -122.316237, 47.602174 ], [ -122.315958, 47.602212 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14121", "project_id": 14, "task_id": 121, "numnodechanges": 0, "numwaychanges": 0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312909, 47.609154 ], [ -122.312869, 47.609214 ], [ -122.312841, 47.609214 ], [ -122.312803, 47.609162 ], [ -122.312909, 47.609154 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1452", "project_id": 14, "task_id": 52, "numnodechanges": 5, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3091, 47.60414 ], [ -122.308965, 47.60433 ], [ -122.308938, 47.60433 ], [ -122.308807, 47.604136 ], [ -122.3091, 47.60414 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14202", "project_id": 14, "task_id": 202, "numnodechanges": 84, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309919, 47.598116 ], [ -122.310154, 47.598229 ], [ -122.310152, 47.599417 ], [ -122.309948, 47.599556 ], [ -122.309919, 47.598116 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14425", "project_id": 14, "task_id": 425, "numnodechanges": 59, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318796, 47.604779 ], [ -122.318192, 47.604786 ], [ -122.318182, 47.604784 ], [ -122.318191, 47.603943 ], [ -122.3188, 47.603941 ], [ -122.318803, 47.603944 ], [ -122.318797, 47.604777 ], [ -122.318796, 47.604779 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14332", "project_id": 14, "task_id": 332, "numnodechanges": 192, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316306, 47.606694 ], [ -122.31727, 47.606691 ], [ -122.317558, 47.606994 ], [ -122.316131, 47.606986 ], [ -122.316131, 47.60685 ], [ -122.316149, 47.60683 ], [ -122.316306, 47.606694 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14155", "project_id": 14, "task_id": 155, "numnodechanges": 117, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316472, 47.599261 ], [ -122.31625, 47.600721 ], [ -122.316179, 47.600781 ], [ -122.31616, 47.600791 ], [ -122.316027, 47.599545 ], [ -122.316096, 47.599182 ], [ -122.316109, 47.599164 ], [ -122.316242, 47.599159 ], [ -122.316401, 47.59917 ], [ -122.316472, 47.599261 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14355", "project_id": 14, "task_id": 355, "numnodechanges": 22, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32136, 47.604576 ], [ -122.321527, 47.604415 ], [ -122.321965, 47.604448 ], [ -122.322231, 47.605085 ], [ -122.32201, 47.605286 ], [ -122.321665, 47.605315 ], [ -122.32136, 47.604576 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14377", "project_id": 14, "task_id": 377, "numnodechanges": 242, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31495, 47.599884 ], [ -122.31511, 47.59943 ], [ -122.315287, 47.599471 ], [ -122.31507, 47.600061 ], [ -122.31495, 47.599884 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14214", "project_id": 14, "task_id": 214, "numnodechanges": 168, "numwaychanges": 26 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313574, 47.602848 ], [ -122.313573, 47.602522 ], [ -122.314566, 47.602449 ], [ -122.314568, 47.602843 ], [ -122.313574, 47.602848 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14132", "project_id": 14, "task_id": 132, "numnodechanges": 10, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309853, 47.607103 ], [ -122.309355, 47.606602 ], [ -122.309278, 47.606314 ], [ -122.309267, 47.606216 ], [ -122.30927, 47.605273 ], [ -122.309493, 47.605194 ], [ -122.309614, 47.605154 ], [ -122.309929, 47.605262 ], [ -122.309931, 47.607101 ], [ -122.309853, 47.607103 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14126", "project_id": 14, "task_id": 126, "numnodechanges": 26, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311902, 47.608721 ], [ -122.311563, 47.609209 ], [ -122.311535, 47.609208 ], [ -122.311192, 47.608752 ], [ -122.311185, 47.608621 ], [ -122.311214, 47.608604 ], [ -122.311839, 47.60861 ], [ -122.311907, 47.608644 ], [ -122.311902, 47.608721 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14150", "project_id": 14, "task_id": 150, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315909, 47.59792 ], [ -122.315434, 47.597799 ], [ -122.315297, 47.597645 ], [ -122.315297, 47.597195 ], [ -122.316532, 47.596949 ], [ -122.316621, 47.597081 ], [ -122.316621, 47.597745 ], [ -122.31625, 47.597888 ], [ -122.316092, 47.597918 ], [ -122.315909, 47.59792 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14221", "project_id": 14, "task_id": 221, "numnodechanges": 0, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310207, 47.603521 ], [ -122.310178, 47.60352 ], [ -122.309875, 47.603068 ], [ -122.310474, 47.603094 ], [ -122.310472, 47.60312 ], [ -122.310207, 47.603521 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14386", "project_id": 14, "task_id": 386, "numnodechanges": 3, "numwaychanges": 1 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32446, 47.605655 ], [ -122.32476, 47.606039 ], [ -122.324448, 47.606327 ], [ -122.324276, 47.606327 ], [ -122.324124, 47.605965 ], [ -122.32446, 47.605655 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14276", "project_id": 14, "task_id": 276, "numnodechanges": 7, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311746, 47.597728 ], [ -122.311977, 47.597772 ], [ -122.311981, 47.598069 ], [ -122.311772, 47.598102 ], [ -122.311396, 47.5981 ], [ -122.311039, 47.598048 ], [ -122.311199, 47.597762 ], [ -122.311447, 47.597726 ], [ -122.311746, 47.597728 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1438", "project_id": 14, "task_id": 38, "numnodechanges": 182, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316541, 47.596623 ], [ -122.316532, 47.596949 ], [ -122.315297, 47.597195 ], [ -122.314936, 47.596672 ], [ -122.314935, 47.596204 ], [ -122.31509, 47.596172 ], [ -122.316521, 47.596077 ], [ -122.316541, 47.596623 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14163", "project_id": 14, "task_id": 163, "numnodechanges": 10, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324162, 47.599662 ], [ -122.324197, 47.599606 ], [ -122.324584, 47.599608 ], [ -122.324666, 47.599763 ], [ -122.324716, 47.599931 ], [ -122.324713, 47.600975 ], [ -122.324063, 47.600831 ], [ -122.324065, 47.599947 ], [ -122.324098, 47.599799 ], [ -122.324162, 47.599662 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14145", "project_id": 14, "task_id": 145, "numnodechanges": 46, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312925, 47.600215 ], [ -122.313552, 47.599605 ], [ -122.313832, 47.599653 ], [ -122.31383, 47.600437 ], [ -122.313675, 47.600545 ], [ -122.313058, 47.600318 ], [ -122.312925, 47.600215 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14153", "project_id": 14, "task_id": 153, "numnodechanges": 138, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317654, 47.598771 ], [ -122.317757, 47.5988 ], [ -122.317763, 47.599771 ], [ -122.317391, 47.599624 ], [ -122.317387, 47.599067 ], [ -122.317654, 47.598771 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1480", "project_id": 14, "task_id": 80, "numnodechanges": 22, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323973, 47.608213 ], [ -122.324231, 47.608012 ], [ -122.324799, 47.608114 ], [ -122.324105, 47.608737 ], [ -122.32391, 47.608844 ], [ -122.32372, 47.60861 ], [ -122.3238, 47.608395 ], [ -122.323973, 47.608213 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14159", "project_id": 14, "task_id": 159, "numnodechanges": 22, "numwaychanges": 14 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323548, 47.598753 ], [ -122.324075, 47.598756 ], [ -122.324096, 47.598775 ], [ -122.324069, 47.5992 ], [ -122.323544, 47.599197 ], [ -122.323548, 47.598753 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14235", "project_id": 14, "task_id": 235, "numnodechanges": 2, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317301, 47.601111 ], [ -122.317544, 47.601594 ], [ -122.317194, 47.601611 ], [ -122.317181, 47.601269 ], [ -122.317256, 47.601142 ], [ -122.317301, 47.601111 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14334", "project_id": 14, "task_id": 334, "numnodechanges": 128, "numwaychanges": 16 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314829, 47.605721 ], [ -122.314832, 47.604965 ], [ -122.315222, 47.604556 ], [ -122.31547, 47.604507 ], [ -122.315753, 47.604562 ], [ -122.315894, 47.604713 ], [ -122.315889, 47.605712 ], [ -122.314829, 47.605721 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1444", "project_id": 14, "task_id": 44, "numnodechanges": 0, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308201, 47.605269 ], [ -122.30709, 47.605262 ], [ -122.307655, 47.60432 ], [ -122.307684, 47.60432 ], [ -122.308201, 47.605269 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14327", "project_id": 14, "task_id": 327, "numnodechanges": 82, "numwaychanges": 15 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318187, 47.603943 ], [ -122.318191, 47.603943 ], [ -122.318182, 47.604784 ], [ -122.317782, 47.604783 ], [ -122.317779, 47.604781 ], [ -122.317783, 47.603943 ], [ -122.318187, 47.603943 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1415", "project_id": 14, "task_id": 15, "numnodechanges": 12, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317972, 47.597621 ], [ -122.318401, 47.597155 ], [ -122.318394, 47.598841 ], [ -122.317967, 47.598753 ], [ -122.317972, 47.597621 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14274", "project_id": 14, "task_id": 274, "numnodechanges": 4, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322519, 47.606886 ], [ -122.322855, 47.60649 ], [ -122.323374, 47.606657 ], [ -122.32336, 47.606736 ], [ -122.323104, 47.606971 ], [ -122.322554, 47.607303 ], [ -122.322429, 47.607184 ], [ -122.322519, 47.606886 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14265", "project_id": 14, "task_id": 265, "numnodechanges": 29, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322663, 47.605992 ], [ -122.322886, 47.605796 ], [ -122.322904, 47.605795 ], [ -122.323333, 47.606052 ], [ -122.32346, 47.606354 ], [ -122.323476, 47.606559 ], [ -122.323374, 47.606657 ], [ -122.322855, 47.60649 ], [ -122.322657, 47.606026 ], [ -122.322663, 47.605992 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1437", "project_id": 14, "task_id": 37, "numnodechanges": 12, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.307657, 47.602679 ], [ -122.307285, 47.602159 ], [ -122.308017, 47.602162 ], [ -122.30769, 47.602678 ], [ -122.307657, 47.602679 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14393", "project_id": 14, "task_id": 393, "numnodechanges": 323, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315774, 47.606374 ], [ -122.314838, 47.606382 ], [ -122.314825, 47.606298 ], [ -122.314826, 47.606042 ], [ -122.314827, 47.606037 ], [ -122.315775, 47.606028 ], [ -122.315774, 47.606374 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14125", "project_id": 14, "task_id": 125, "numnodechanges": 197, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311839, 47.60861 ], [ -122.311214, 47.608604 ], [ -122.311216, 47.607709 ], [ -122.311842, 47.607705 ], [ -122.311839, 47.60861 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14420", "project_id": 14, "task_id": 420, "numnodechanges": 3, "numwaychanges": 1 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322653, 47.600293 ], [ -122.322796, 47.60063 ], [ -122.322015, 47.601366 ], [ -122.321542, 47.601272 ], [ -122.321632, 47.600759 ], [ -122.322282, 47.600131 ], [ -122.322653, 47.600293 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14219", "project_id": 14, "task_id": 219, "numnodechanges": 59, "numwaychanges": 14 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31047, 47.603932 ], [ -122.310207, 47.603521 ], [ -122.310472, 47.60312 ], [ -122.31047, 47.603932 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14286", "project_id": 14, "task_id": 286, "numnodechanges": 47, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311288, 47.60352 ], [ -122.311426, 47.603315 ], [ -122.311916, 47.603241 ], [ -122.312076, 47.603287 ], [ -122.312076, 47.603747 ], [ -122.311533, 47.603905 ], [ -122.311288, 47.60352 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14374", "project_id": 14, "task_id": 374, "numnodechanges": 64, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314805, 47.601717 ], [ -122.314657, 47.60217 ], [ -122.314416, 47.601966 ], [ -122.314403, 47.601602 ], [ -122.314806, 47.601605 ], [ -122.314805, 47.601717 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14148", "project_id": 14, "task_id": 148, "numnodechanges": 690, "numwaychanges": 28 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314386, 47.60044 ], [ -122.31383, 47.600437 ], [ -122.313832, 47.599653 ], [ -122.313908, 47.59961 ], [ -122.3143, 47.599617 ], [ -122.314395, 47.599723 ], [ -122.314386, 47.60044 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14370", "project_id": 14, "task_id": 370, "numnodechanges": 8, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313123, 47.6031 ], [ -122.312899, 47.603517 ], [ -122.312867, 47.603519 ], [ -122.312533, 47.603099 ], [ -122.312609, 47.603095 ], [ -122.313123, 47.6031 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14161", "project_id": 14, "task_id": 161, "numnodechanges": 12, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323091, 47.59978 ], [ -122.322904, 47.599955 ], [ -122.322832, 47.600011 ], [ -122.322731, 47.599105 ], [ -122.322771, 47.598926 ], [ -122.322866, 47.598729 ], [ -122.3232, 47.598762 ], [ -122.323191, 47.599658 ], [ -122.323091, 47.59978 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1451", "project_id": 14, "task_id": 51, "numnodechanges": 27, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312203, 47.607393 ], [ -122.312206, 47.606789 ], [ -122.313395, 47.606784 ], [ -122.313716, 47.60731 ], [ -122.313515, 47.607709 ], [ -122.312535, 47.607714 ], [ -122.312203, 47.607393 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1433", "project_id": 14, "task_id": 33, "numnodechanges": 41, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324666, 47.599763 ], [ -122.324584, 47.599608 ], [ -122.32472, 47.599439 ], [ -122.32537, 47.599443 ], [ -122.325492, 47.59961 ], [ -122.325413, 47.599768 ], [ -122.324666, 47.599763 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14328", "project_id": 14, "task_id": 328, "numnodechanges": 16, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317117, 47.603939 ], [ -122.317116, 47.603938 ], [ -122.317116, 47.603107 ], [ -122.31712, 47.603103 ], [ -122.317784, 47.603112 ], [ -122.317782, 47.603942 ], [ -122.317117, 47.603939 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1446", "project_id": 14, "task_id": 46, "numnodechanges": 168, "numwaychanges": 14 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308296, 47.606215 ], [ -122.308298, 47.605273 ], [ -122.308309, 47.605266 ], [ -122.30927, 47.605273 ], [ -122.309267, 47.606216 ], [ -122.308296, 47.606215 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14238", "project_id": 14, "task_id": 238, "numnodechanges": 153, "numwaychanges": 27 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317301, 47.601111 ], [ -122.317256, 47.601142 ], [ -122.316179, 47.600781 ], [ -122.31625, 47.600721 ], [ -122.316663, 47.600489 ], [ -122.31762, 47.600779 ], [ -122.317301, 47.601111 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "147", "project_id": 14, "task_id": 7, "numnodechanges": 4, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308309, 47.605266 ], [ -122.308309, 47.605237 ], [ -122.308938, 47.60433 ], [ -122.308965, 47.60433 ], [ -122.309493, 47.605194 ], [ -122.30927, 47.605273 ], [ -122.308309, 47.605266 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14192", "project_id": 14, "task_id": 192, "numnodechanges": 43, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311962, 47.598859 ], [ -122.312204, 47.598696 ], [ -122.312605, 47.599077 ], [ -122.312369, 47.599857 ], [ -122.312303, 47.599833 ], [ -122.311725, 47.599418 ], [ -122.311723, 47.599068 ], [ -122.311962, 47.598859 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14260", "project_id": 14, "task_id": 260, "numnodechanges": 5, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320263, 47.606703 ], [ -122.320422, 47.606981 ], [ -122.319983, 47.607784 ], [ -122.319319, 47.607005 ], [ -122.319745, 47.606715 ], [ -122.320263, 47.606703 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14434", "project_id": 14, "task_id": 434, "numnodechanges": 19, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319745, 47.603114 ], [ -122.319748, 47.602231 ], [ -122.320168, 47.602029 ], [ -122.320422, 47.602204 ], [ -122.320419, 47.602788 ], [ -122.320353, 47.60308 ], [ -122.320143, 47.603116 ], [ -122.319745, 47.603114 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14248", "project_id": 14, "task_id": 248, "numnodechanges": 39, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323261, 47.600975 ], [ -122.324063, 47.600831 ], [ -122.324713, 47.600975 ], [ -122.32487, 47.601069 ], [ -122.324867, 47.602201 ], [ -122.323391, 47.602347 ], [ -122.323365, 47.602292 ], [ -122.323256, 47.601947 ], [ -122.323261, 47.600975 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14388", "project_id": 14, "task_id": 388, "numnodechanges": 197, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318771, 47.605793 ], [ -122.318188, 47.605707 ], [ -122.318192, 47.604786 ], [ -122.318796, 47.604779 ], [ -122.318793, 47.605767 ], [ -122.318771, 47.605793 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1497", "project_id": 14, "task_id": 97, "numnodechanges": 17, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.30769, 47.602678 ], [ -122.308017, 47.602162 ], [ -122.308315, 47.602144 ], [ -122.30832, 47.60215 ], [ -122.308318, 47.603089 ], [ -122.307984, 47.603093 ], [ -122.307955, 47.603091 ], [ -122.30769, 47.602678 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14256", "project_id": 14, "task_id": 256, "numnodechanges": 12, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31547, 47.604507 ], [ -122.315472, 47.603174 ], [ -122.315952, 47.603061 ], [ -122.316325, 47.603225 ], [ -122.316325, 47.603936 ], [ -122.315753, 47.604562 ], [ -122.31547, 47.604507 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14234", "project_id": 14, "task_id": 234, "numnodechanges": 96, "numwaychanges": 14 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318035, 47.601528 ], [ -122.317627, 47.601919 ], [ -122.317628, 47.601638 ], [ -122.318038, 47.601203 ], [ -122.318035, 47.601528 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14311", "project_id": 14, "task_id": 311, "numnodechanges": 161, "numwaychanges": 21 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317116, 47.603938 ], [ -122.316325, 47.603936 ], [ -122.316325, 47.603225 ], [ -122.316505, 47.603107 ], [ -122.317116, 47.603107 ], [ -122.317116, 47.603938 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14119", "project_id": 14, "task_id": 119, "numnodechanges": 29, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313118, 47.608998 ], [ -122.313119, 47.609597 ], [ -122.312869, 47.609214 ], [ -122.312909, 47.609154 ], [ -122.313118, 47.608998 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14435", "project_id": 14, "task_id": 435, "numnodechanges": 326, "numwaychanges": 22 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320173, 47.601367 ], [ -122.320885, 47.60122 ], [ -122.321158, 47.601358 ], [ -122.321151, 47.602199 ], [ -122.320422, 47.602204 ], [ -122.320168, 47.602029 ], [ -122.320173, 47.601367 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1475", "project_id": 14, "task_id": 75, "numnodechanges": 24, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326226, 47.604395 ], [ -122.325431, 47.604774 ], [ -122.324858, 47.60473 ], [ -122.324715, 47.604413 ], [ -122.325945, 47.603293 ], [ -122.325985, 47.60332 ], [ -122.326372, 47.603792 ], [ -122.326226, 47.604395 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14179", "project_id": 14, "task_id": 179, "numnodechanges": 90, "numwaychanges": 12 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32336, 47.606736 ], [ -122.32356, 47.607202 ], [ -122.323296, 47.607443 ], [ -122.323104, 47.606971 ], [ -122.32336, 47.606736 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14223", "project_id": 14, "task_id": 223, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.30959, 47.600533 ], [ -122.309558, 47.600431 ], [ -122.309625, 47.600223 ], [ -122.310629, 47.600222 ], [ -122.31083, 47.600551 ], [ -122.310459, 47.600616 ], [ -122.3101, 47.600616 ], [ -122.30959, 47.600533 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14147", "project_id": 14, "task_id": 147, "numnodechanges": 452, "numwaychanges": 21 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313908, 47.59961 ], [ -122.313907, 47.59925 ], [ -122.314274, 47.598742 ], [ -122.314441, 47.59872 ], [ -122.314496, 47.598765 ], [ -122.314499, 47.599216 ], [ -122.3143, 47.599617 ], [ -122.313908, 47.59961 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14231", "project_id": 14, "task_id": 231, "numnodechanges": 203, "numwaychanges": 22 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315897, 47.600859 ], [ -122.315792, 47.599977 ], [ -122.316027, 47.599545 ], [ -122.31616, 47.600791 ], [ -122.316101, 47.600839 ], [ -122.315897, 47.600859 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1473", "project_id": 14, "task_id": 73, "numnodechanges": 145, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322573, 47.605046 ], [ -122.322231, 47.605085 ], [ -122.321965, 47.604448 ], [ -122.322394, 47.604057 ], [ -122.322743, 47.604889 ], [ -122.322573, 47.605046 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1440", "project_id": 14, "task_id": 40, "numnodechanges": 7, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314496, 47.598765 ], [ -122.314441, 47.59872 ], [ -122.314443, 47.598008 ], [ -122.314966, 47.597837 ], [ -122.314962, 47.598766 ], [ -122.314959, 47.598767 ], [ -122.314496, 47.598765 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14389", "project_id": 14, "task_id": 389, "numnodechanges": 97, "numwaychanges": 19 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319743, 47.605712 ], [ -122.319747, 47.605714 ], [ -122.319745, 47.606715 ], [ -122.319319, 47.607005 ], [ -122.318769, 47.606995 ], [ -122.318771, 47.605793 ], [ -122.318793, 47.605767 ], [ -122.319371, 47.605711 ], [ -122.319743, 47.605712 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14451", "project_id": 14, "task_id": 451, "numnodechanges": 73, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319718, 47.603931 ], [ -122.319705, 47.603144 ], [ -122.319745, 47.603114 ], [ -122.320143, 47.603116 ], [ -122.320132, 47.603949 ], [ -122.319741, 47.603949 ], [ -122.319718, 47.603931 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14165", "project_id": 14, "task_id": 165, "numnodechanges": 3, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322743, 47.604889 ], [ -122.322394, 47.604057 ], [ -122.322444, 47.603916 ], [ -122.32344, 47.603899 ], [ -122.323315, 47.604594 ], [ -122.323117, 47.604808 ], [ -122.322743, 47.604889 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1423", "project_id": 14, "task_id": 23, "numnodechanges": 59, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324867, 47.602201 ], [ -122.325104, 47.602526 ], [ -122.323689, 47.603663 ], [ -122.323293, 47.602724 ], [ -122.323391, 47.602347 ], [ -122.324867, 47.602201 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1490", "project_id": 14, "task_id": 90, "numnodechanges": 18, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308511, 47.60216 ], [ -122.309305, 47.602161 ], [ -122.308978, 47.602678 ], [ -122.308946, 47.602681 ], [ -122.308511, 47.60216 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1498", "project_id": 14, "task_id": 98, "numnodechanges": 83, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313076, 47.59898 ], [ -122.313552, 47.599605 ], [ -122.312925, 47.600215 ], [ -122.312439, 47.600117 ], [ -122.31243, 47.600093 ], [ -122.312369, 47.599857 ], [ -122.312605, 47.599077 ], [ -122.312981, 47.598954 ], [ -122.313076, 47.59898 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14372", "project_id": 14, "task_id": 372, "numnodechanges": 325, "numwaychanges": 26 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314416, 47.601966 ], [ -122.313981, 47.601994 ], [ -122.313984, 47.601279 ], [ -122.314303, 47.601274 ], [ -122.314403, 47.601602 ], [ -122.314416, 47.601966 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1455", "project_id": 14, "task_id": 55, "numnodechanges": 34, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308807, 47.604136 ], [ -122.308938, 47.60433 ], [ -122.308309, 47.605237 ], [ -122.308314, 47.604061 ], [ -122.308807, 47.604136 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1471", "project_id": 14, "task_id": 71, "numnodechanges": 301, "numwaychanges": 27 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325559, 47.60578 ], [ -122.325868, 47.606509 ], [ -122.325624, 47.60673 ], [ -122.325284, 47.606767 ], [ -122.32497, 47.606016 ], [ -122.325212, 47.605792 ], [ -122.325559, 47.60578 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14426", "project_id": 14, "task_id": 426, "numnodechanges": 132, "numwaychanges": 14 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319371, 47.605711 ], [ -122.318793, 47.605767 ], [ -122.318796, 47.604779 ], [ -122.318797, 47.604777 ], [ -122.319373, 47.604791 ], [ -122.319371, 47.605711 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14198", "project_id": 14, "task_id": 198, "numnodechanges": 239, "numwaychanges": 20 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309626, 47.59987 ], [ -122.309625, 47.600223 ], [ -122.309558, 47.600431 ], [ -122.307765, 47.600418 ], [ -122.307501, 47.600213 ], [ -122.307825, 47.599804 ], [ -122.309572, 47.599808 ], [ -122.309626, 47.59987 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14195", "project_id": 14, "task_id": 195, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309464, 47.599542 ], [ -122.308019, 47.599559 ], [ -122.308169, 47.59937 ], [ -122.309415, 47.599367 ], [ -122.309464, 47.599542 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1464", "project_id": 14, "task_id": 64, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317511, 47.597921 ], [ -122.317972, 47.597621 ], [ -122.317967, 47.598753 ], [ -122.317757, 47.5988 ], [ -122.317654, 47.598771 ], [ -122.317625, 47.598744 ], [ -122.317509, 47.598451 ], [ -122.317511, 47.597921 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1411", "project_id": 14, "task_id": 11, "numnodechanges": 78, "numwaychanges": 14 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324727, 47.598159 ], [ -122.324741, 47.598139 ], [ -122.324761, 47.59815 ], [ -122.325451, 47.598717 ], [ -122.325372, 47.598781 ], [ -122.324725, 47.598777 ], [ -122.324727, 47.598159 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1488", "project_id": 14, "task_id": 88, "numnodechanges": 21, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308946, 47.602681 ], [ -122.308978, 47.602678 ], [ -122.309226, 47.603103 ], [ -122.30866, 47.603103 ], [ -122.308946, 47.602681 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14345", "project_id": 14, "task_id": 345, "numnodechanges": 156, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317289, 47.602202 ], [ -122.317094, 47.601882 ], [ -122.317095, 47.601863 ], [ -122.317194, 47.601611 ], [ -122.317544, 47.601594 ], [ -122.317628, 47.601638 ], [ -122.317627, 47.601919 ], [ -122.317617, 47.602138 ], [ -122.317595, 47.602188 ], [ -122.317289, 47.602202 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14228", "project_id": 14, "task_id": 228, "numnodechanges": 80, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310013, 47.601241 ], [ -122.309875, 47.601206 ], [ -122.309588, 47.601042 ], [ -122.30959, 47.600533 ], [ -122.3101, 47.600616 ], [ -122.310269, 47.600847 ], [ -122.310013, 47.601241 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14224", "project_id": 14, "task_id": 224, "numnodechanges": 7, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310307, 47.600847 ], [ -122.310601, 47.601291 ], [ -122.310146, 47.601289 ], [ -122.310013, 47.601241 ], [ -122.310269, 47.600847 ], [ -122.310307, 47.600847 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14381", "project_id": 14, "task_id": 381, "numnodechanges": 160, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315157, 47.600206 ], [ -122.315145, 47.600772 ], [ -122.31491, 47.600775 ], [ -122.314386, 47.60044 ], [ -122.314395, 47.599723 ], [ -122.314726, 47.599765 ], [ -122.31495, 47.599884 ], [ -122.31507, 47.600061 ], [ -122.315157, 47.600206 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14315", "project_id": 14, "task_id": 315, "numnodechanges": 58, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322653, 47.600293 ], [ -122.322832, 47.600011 ], [ -122.322904, 47.599955 ], [ -122.324065, 47.599947 ], [ -122.324063, 47.600831 ], [ -122.323261, 47.600975 ], [ -122.322796, 47.60063 ], [ -122.322653, 47.600293 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14430", "project_id": 14, "task_id": 430, "numnodechanges": 101, "numwaychanges": 14 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316542, 47.605389 ], [ -122.317111, 47.60539 ], [ -122.317254, 47.605647 ], [ -122.316541, 47.60565 ], [ -122.316542, 47.605389 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14394", "project_id": 14, "task_id": 394, "numnodechanges": 129, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31351, 47.606302 ], [ -122.313511, 47.606011 ], [ -122.314826, 47.606042 ], [ -122.314825, 47.606298 ], [ -122.31351, 47.606302 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14184", "project_id": 14, "task_id": 184, "numnodechanges": 91, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313036, 47.598311 ], [ -122.312929, 47.598121 ], [ -122.313568, 47.59756 ], [ -122.313732, 47.597844 ], [ -122.31346, 47.598106 ], [ -122.313036, 47.598311 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14419", "project_id": 14, "task_id": 419, "numnodechanges": 23, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321632, 47.600759 ], [ -122.321542, 47.601272 ], [ -122.321351, 47.601279 ], [ -122.321357, 47.600795 ], [ -122.321367, 47.600759 ], [ -122.321632, 47.600759 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14229", "project_id": 14, "task_id": 229, "numnodechanges": 14, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3101, 47.600616 ], [ -122.310459, 47.600616 ], [ -122.310307, 47.600847 ], [ -122.310269, 47.600847 ], [ -122.3101, 47.600616 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14427", "project_id": 14, "task_id": 427, "numnodechanges": 78, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317254, 47.605647 ], [ -122.317299, 47.605706 ], [ -122.317236, 47.605792 ], [ -122.316542, 47.605793 ], [ -122.316519, 47.60572 ], [ -122.316541, 47.60565 ], [ -122.317254, 47.605647 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14348", "project_id": 14, "task_id": 348, "numnodechanges": 4, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321072, 47.607025 ], [ -122.320481, 47.60702 ], [ -122.320422, 47.606981 ], [ -122.320263, 47.606703 ], [ -122.320323, 47.606633 ], [ -122.32094, 47.606639 ], [ -122.321072, 47.607024 ], [ -122.321072, 47.607025 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14317", "project_id": 14, "task_id": 317, "numnodechanges": 178, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321496, 47.603135 ], [ -122.322132, 47.603374 ], [ -122.322225, 47.603593 ], [ -122.321506, 47.604203 ], [ -122.321266, 47.603649 ], [ -122.321435, 47.603192 ], [ -122.321496, 47.603135 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1476", "project_id": 14, "task_id": 76, "numnodechanges": 13, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325985, 47.60332 ], [ -122.325945, 47.603293 ], [ -122.325673, 47.602907 ], [ -122.32685, 47.602095 ], [ -122.327268, 47.602312 ], [ -122.327287, 47.602417 ], [ -122.325985, 47.60332 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14168", "project_id": 14, "task_id": 168, "numnodechanges": 14, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323374, 47.606657 ], [ -122.323476, 47.606559 ], [ -122.323926, 47.60659 ], [ -122.324186, 47.60723 ], [ -122.324014, 47.607376 ], [ -122.32356, 47.607202 ], [ -122.32336, 47.606736 ], [ -122.323374, 47.606657 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14275", "project_id": 14, "task_id": 275, "numnodechanges": 12, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311625, 47.597493 ], [ -122.311746, 47.597728 ], [ -122.311447, 47.597726 ], [ -122.311587, 47.597493 ], [ -122.311625, 47.597493 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14230", "project_id": 14, "task_id": 230, "numnodechanges": 392, "numwaychanges": 19 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315305, 47.602222 ], [ -122.315299, 47.60305 ], [ -122.314706, 47.60315 ], [ -122.314568, 47.602843 ], [ -122.314566, 47.602449 ], [ -122.31469, 47.602219 ], [ -122.315305, 47.602222 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14453", "project_id": 14, "task_id": 453, "numnodechanges": 95, "numwaychanges": 16 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31974, 47.604788 ], [ -122.319745, 47.604792 ], [ -122.319743, 47.605712 ], [ -122.319371, 47.605711 ], [ -122.319373, 47.604791 ], [ -122.319378, 47.60479 ], [ -122.31974, 47.604788 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1445", "project_id": 14, "task_id": 45, "numnodechanges": 80, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308291, 47.606288 ], [ -122.308296, 47.606215 ], [ -122.309267, 47.606216 ], [ -122.309278, 47.606314 ], [ -122.308291, 47.606288 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1478", "project_id": 14, "task_id": 78, "numnodechanges": 208, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326569, 47.603794 ], [ -122.32776, 47.604236 ], [ -122.327702, 47.604628 ], [ -122.327184, 47.605077 ], [ -122.326558, 47.605139 ], [ -122.326533, 47.605129 ], [ -122.326226, 47.604395 ], [ -122.326372, 47.603792 ], [ -122.326569, 47.603794 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14201", "project_id": 14, "task_id": 201, "numnodechanges": 191, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31063, 47.599798 ], [ -122.310629, 47.600222 ], [ -122.309625, 47.600223 ], [ -122.309626, 47.59987 ], [ -122.309705, 47.599827 ], [ -122.31063, 47.599798 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14216", "project_id": 14, "task_id": 216, "numnodechanges": 4, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312895, 47.604339 ], [ -122.312866, 47.604342 ], [ -122.312519, 47.603934 ], [ -122.312621, 47.603928 ], [ -122.313187, 47.603934 ], [ -122.312895, 47.604339 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14104", "project_id": 14, "task_id": 104, "numnodechanges": 66, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314274, 47.598742 ], [ -122.313907, 47.59925 ], [ -122.313658, 47.598993 ], [ -122.314046, 47.598691 ], [ -122.314274, 47.598742 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14353", "project_id": 14, "task_id": 353, "numnodechanges": 230, "numwaychanges": 23 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321303, 47.605645 ], [ -122.321167, 47.60558 ], [ -122.320921, 47.604903 ], [ -122.321266, 47.604585 ], [ -122.32136, 47.604576 ], [ -122.321665, 47.605315 ], [ -122.321303, 47.605645 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14189", "project_id": 14, "task_id": 189, "numnodechanges": 0, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311769, 47.598597 ], [ -122.31141, 47.598588 ], [ -122.311582, 47.598331 ], [ -122.311617, 47.598333 ], [ -122.311769, 47.598597 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14212", "project_id": 14, "task_id": 212, "numnodechanges": 92, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313984, 47.601279 ], [ -122.313981, 47.601994 ], [ -122.313734, 47.602143 ], [ -122.313737, 47.601192 ], [ -122.313984, 47.601279 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14136", "project_id": 14, "task_id": 136, "numnodechanges": 187, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310559, 47.607112 ], [ -122.310555, 47.608625 ], [ -122.310304, 47.608763 ], [ -122.309938, 47.60856 ], [ -122.309941, 47.607105 ], [ -122.310559, 47.607112 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14208", "project_id": 14, "task_id": 208, "numnodechanges": 4, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317489, 47.609692 ], [ -122.317255, 47.60985 ], [ -122.316972, 47.609978 ], [ -122.316163, 47.609975 ], [ -122.316149, 47.609953 ], [ -122.316397, 47.609391 ], [ -122.317798, 47.609396 ], [ -122.317489, 47.609692 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14384", "project_id": 14, "task_id": 384, "numnodechanges": 32, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323926, 47.60659 ], [ -122.323476, 47.606559 ], [ -122.32346, 47.606354 ], [ -122.323788, 47.606061 ], [ -122.323828, 47.606066 ], [ -122.324152, 47.606388 ], [ -122.323926, 47.60659 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14400", "project_id": 14, "task_id": 400, "numnodechanges": 1, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313071, 47.602455 ], [ -122.312904, 47.602681 ], [ -122.312874, 47.60268 ], [ -122.312716, 47.602456 ], [ -122.313071, 47.602455 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1421", "project_id": 14, "task_id": 21, "numnodechanges": 6, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324727, 47.598159 ], [ -122.324725, 47.598777 ], [ -122.324722, 47.598779 ], [ -122.324096, 47.598775 ], [ -122.324075, 47.598756 ], [ -122.324077, 47.598143 ], [ -122.324727, 47.598159 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1486", "project_id": 14, "task_id": 86, "numnodechanges": 305, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320921, 47.604903 ], [ -122.320429, 47.604902 ], [ -122.320359, 47.604821 ], [ -122.320771, 47.604408 ], [ -122.321021, 47.604405 ], [ -122.321266, 47.604585 ], [ -122.320921, 47.604903 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1453", "project_id": 14, "task_id": 53, "numnodechanges": 2, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308947, 47.603521 ], [ -122.308974, 47.603522 ], [ -122.30913, 47.603769 ], [ -122.308776, 47.603767 ], [ -122.308947, 47.603521 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1428", "project_id": 14, "task_id": 28, "numnodechanges": 67, "numwaychanges": 28 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326028, 47.601975 ], [ -122.32603, 47.601294 ], [ -122.326691, 47.601304 ], [ -122.326708, 47.601318 ], [ -122.326707, 47.601873 ], [ -122.326028, 47.601975 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14387", "project_id": 14, "task_id": 387, "numnodechanges": 6, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323852, 47.605455 ], [ -122.32388, 47.60543 ], [ -122.32416, 47.605322 ], [ -122.324316, 47.605308 ], [ -122.32446, 47.605655 ], [ -122.324124, 47.605965 ], [ -122.32403, 47.605882 ], [ -122.323852, 47.605455 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "146", "project_id": 14, "task_id": 6, "numnodechanges": 39, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3097, 47.607193 ], [ -122.309155, 47.608007 ], [ -122.308267, 47.607277 ], [ -122.308222, 47.607221 ], [ -122.3097, 47.607193 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14391", "project_id": 14, "task_id": 391, "numnodechanges": 75, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316506, 47.606085 ], [ -122.316504, 47.606379 ], [ -122.316306, 47.606694 ], [ -122.316149, 47.60683 ], [ -122.316153, 47.606009 ], [ -122.316506, 47.606085 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14199", "project_id": 14, "task_id": 199, "numnodechanges": 28, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309948, 47.599556 ], [ -122.310152, 47.599417 ], [ -122.310747, 47.599437 ], [ -122.310785, 47.599531 ], [ -122.31063, 47.599798 ], [ -122.309705, 47.599827 ], [ -122.309948, 47.599556 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14259", "project_id": 14, "task_id": 259, "numnodechanges": 70, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319319, 47.607005 ], [ -122.319983, 47.607784 ], [ -122.320083, 47.608025 ], [ -122.320014, 47.608325 ], [ -122.31984, 47.608671 ], [ -122.31958, 47.609034 ], [ -122.319118, 47.609491 ], [ -122.319086, 47.609515 ], [ -122.319023, 47.609471 ], [ -122.318577, 47.607148 ], [ -122.318769, 47.606995 ], [ -122.319319, 47.607005 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14111", "project_id": 14, "task_id": 111, "numnodechanges": 24, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31122, 47.600296 ], [ -122.312344, 47.600307 ], [ -122.312317, 47.600383 ], [ -122.311127, 47.600441 ], [ -122.31122, 47.600296 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14261", "project_id": 14, "task_id": 261, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320301, 47.605711 ], [ -122.320435, 47.606085 ], [ -122.320436, 47.606314 ], [ -122.320323, 47.606633 ], [ -122.320263, 47.606703 ], [ -122.319745, 47.606715 ], [ -122.319747, 47.605714 ], [ -122.320301, 47.605711 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14452", "project_id": 14, "task_id": 452, "numnodechanges": 57, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319741, 47.603949 ], [ -122.320132, 47.603949 ], [ -122.320339, 47.603985 ], [ -122.320312, 47.604791 ], [ -122.319745, 47.604792 ], [ -122.31974, 47.604788 ], [ -122.319741, 47.603949 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1436", "project_id": 14, "task_id": 36, "numnodechanges": 425, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308315, 47.602144 ], [ -122.308314, 47.601261 ], [ -122.30935, 47.601264 ], [ -122.309348, 47.602158 ], [ -122.309305, 47.602161 ], [ -122.308511, 47.60216 ], [ -122.30832, 47.60215 ], [ -122.308315, 47.602144 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14445", "project_id": 14, "task_id": 445, "numnodechanges": 129, "numwaychanges": 15 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318901, 47.601521 ], [ -122.318904, 47.601781 ], [ -122.318457, 47.601956 ], [ -122.318043, 47.601755 ], [ -122.318035, 47.601528 ], [ -122.318038, 47.601203 ], [ -122.318246, 47.600688 ], [ -122.318444, 47.600803 ], [ -122.318505, 47.600842 ], [ -122.318784, 47.601249 ], [ -122.318901, 47.601521 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14138", "project_id": 14, "task_id": 138, "numnodechanges": 4, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317489, 47.609692 ], [ -122.317466, 47.610471 ], [ -122.317254, 47.610485 ], [ -122.317255, 47.60985 ], [ -122.317489, 47.609692 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1463", "project_id": 14, "task_id": 63, "numnodechanges": 364, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316783, 47.59845 ], [ -122.316785, 47.597921 ], [ -122.317511, 47.597921 ], [ -122.317509, 47.598451 ], [ -122.316783, 47.59845 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14346", "project_id": 14, "task_id": 346, "numnodechanges": 8, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317787, 47.602355 ], [ -122.317785, 47.603111 ], [ -122.317784, 47.603112 ], [ -122.31712, 47.603103 ], [ -122.317122, 47.602388 ], [ -122.317289, 47.602202 ], [ -122.317595, 47.602188 ], [ -122.31778, 47.602349 ], [ -122.317787, 47.602355 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1485", "project_id": 14, "task_id": 85, "numnodechanges": 6, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323047, 47.608104 ], [ -122.323713, 47.608609 ], [ -122.32315, 47.608848 ], [ -122.322949, 47.608376 ], [ -122.323047, 47.608104 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14390", "project_id": 14, "task_id": 390, "numnodechanges": 343, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31711, 47.606035 ], [ -122.317109, 47.606377 ], [ -122.316504, 47.606379 ], [ -122.316506, 47.606085 ], [ -122.316541, 47.606037 ], [ -122.31711, 47.606035 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14351", "project_id": 14, "task_id": 351, "numnodechanges": 21, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322663, 47.605992 ], [ -122.322657, 47.606026 ], [ -122.3223, 47.606352 ], [ -122.32184, 47.606404 ], [ -122.3218, 47.606158 ], [ -122.322216, 47.605777 ], [ -122.322663, 47.605992 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14146", "project_id": 14, "task_id": 146, "numnodechanges": 142, "numwaychanges": 17 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312235, 47.60127 ], [ -122.312235, 47.600644 ], [ -122.312317, 47.600383 ], [ -122.312344, 47.600307 ], [ -122.312439, 47.600117 ], [ -122.312925, 47.600215 ], [ -122.313058, 47.600318 ], [ -122.313055, 47.601272 ], [ -122.312235, 47.60127 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1466", "project_id": 14, "task_id": 66, "numnodechanges": 0, "numwaychanges": 0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324062, 47.597763 ], [ -122.324741, 47.598139 ], [ -122.324727, 47.598159 ], [ -122.324077, 47.598143 ], [ -122.323952, 47.59794 ], [ -122.324062, 47.597763 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14333", "project_id": 14, "task_id": 333, "numnodechanges": 88, "numwaychanges": 17 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314828, 47.605724 ], [ -122.313431, 47.605694 ], [ -122.313242, 47.605291 ], [ -122.313352, 47.60517 ], [ -122.313561, 47.604955 ], [ -122.314832, 47.604965 ], [ -122.314829, 47.605721 ], [ -122.314828, 47.605724 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14371", "project_id": 14, "task_id": 371, "numnodechanges": 0, "numwaychanges": 1 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314806, 47.601605 ], [ -122.314403, 47.601602 ], [ -122.314303, 47.601274 ], [ -122.31491, 47.600775 ], [ -122.315145, 47.600772 ], [ -122.315243, 47.600837 ], [ -122.314806, 47.601605 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14320", "project_id": 14, "task_id": 320, "numnodechanges": 15, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323777, 47.605482 ], [ -122.323356, 47.605382 ], [ -122.323117, 47.604808 ], [ -122.323315, 47.604594 ], [ -122.32361, 47.604776 ], [ -122.32388, 47.60543 ], [ -122.323852, 47.605455 ], [ -122.323777, 47.605482 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14392", "project_id": 14, "task_id": 392, "numnodechanges": 110, "numwaychanges": 17 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316542, 47.605389 ], [ -122.316054, 47.604775 ], [ -122.317109, 47.604778 ], [ -122.317113, 47.604781 ], [ -122.317111, 47.60539 ], [ -122.316542, 47.605389 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14441", "project_id": 14, "task_id": 441, "numnodechanges": 18, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318987, 47.602157 ], [ -122.318552, 47.602588 ], [ -122.318189, 47.602412 ], [ -122.318129, 47.602358 ], [ -122.318433, 47.601978 ], [ -122.318457, 47.601956 ], [ -122.318904, 47.601781 ], [ -122.319049, 47.602047 ], [ -122.318987, 47.602157 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1410", "project_id": 14, "task_id": 10, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325372, 47.598781 ], [ -122.325451, 47.598717 ], [ -122.326038, 47.599199 ], [ -122.326037, 47.599611 ], [ -122.326033, 47.599613 ], [ -122.325492, 47.59961 ], [ -122.32537, 47.599443 ], [ -122.325372, 47.598781 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "145", "project_id": 14, "task_id": 5, "numnodechanges": 2, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326691, 47.601304 ], [ -122.326697, 47.60046 ], [ -122.327059, 47.600462 ], [ -122.327085, 47.600495 ], [ -122.32744, 47.601283 ], [ -122.326708, 47.601318 ], [ -122.326691, 47.601304 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14226", "project_id": 14, "task_id": 226, "numnodechanges": 331, "numwaychanges": 23 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310601, 47.601291 ], [ -122.310933, 47.60132 ], [ -122.310931, 47.601813 ], [ -122.310144, 47.601803 ], [ -122.310146, 47.601289 ], [ -122.310601, 47.601291 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14149", "project_id": 14, "task_id": 149, "numnodechanges": 35, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316092, 47.597918 ], [ -122.31625, 47.597888 ], [ -122.316242, 47.599159 ], [ -122.316109, 47.599164 ], [ -122.316088, 47.599144 ], [ -122.316092, 47.597918 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14108", "project_id": 14, "task_id": 108, "numnodechanges": 175, "numwaychanges": 23 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310965, 47.598632 ], [ -122.31141, 47.598588 ], [ -122.311769, 47.598597 ], [ -122.312193, 47.59867 ], [ -122.312204, 47.598696 ], [ -122.311962, 47.598859 ], [ -122.311216, 47.598859 ], [ -122.310965, 47.598632 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14403", "project_id": 14, "task_id": 403, "numnodechanges": 71, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312874, 47.60268 ], [ -122.312609, 47.603095 ], [ -122.312533, 47.603099 ], [ -122.312204, 47.603095 ], [ -122.312202, 47.602482 ], [ -122.312231, 47.602395 ], [ -122.312716, 47.602456 ], [ -122.312874, 47.60268 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14210", "project_id": 14, "task_id": 210, "numnodechanges": 185, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310732, 47.60295 ], [ -122.310474, 47.603094 ], [ -122.309875, 47.603068 ], [ -122.309625, 47.603042 ], [ -122.309624, 47.602389 ], [ -122.310749, 47.602516 ], [ -122.310747, 47.602917 ], [ -122.310732, 47.60295 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14411", "project_id": 14, "task_id": 411, "numnodechanges": 194, "numwaychanges": 16 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317054, 47.600076 ], [ -122.317059, 47.599616 ], [ -122.317391, 47.599624 ], [ -122.317763, 47.599771 ], [ -122.318165, 47.600138 ], [ -122.318145, 47.600411 ], [ -122.317054, 47.600076 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14190", "project_id": 14, "task_id": 190, "numnodechanges": 415, "numwaychanges": 26 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311723, 47.599068 ], [ -122.311725, 47.599418 ], [ -122.311395, 47.599422 ], [ -122.311394, 47.599068 ], [ -122.311723, 47.599068 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14247", "project_id": 14, "task_id": 247, "numnodechanges": 22, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323365, 47.602292 ], [ -122.322102, 47.602315 ], [ -122.321895, 47.602179 ], [ -122.322018, 47.601945 ], [ -122.323256, 47.601947 ], [ -122.323365, 47.602292 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14373", "project_id": 14, "task_id": 373, "numnodechanges": 496, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314303, 47.601274 ], [ -122.313984, 47.601279 ], [ -122.313737, 47.601192 ], [ -122.313673, 47.601155 ], [ -122.313675, 47.600545 ], [ -122.31383, 47.600437 ], [ -122.314386, 47.60044 ], [ -122.31491, 47.600775 ], [ -122.314303, 47.601274 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14309", "project_id": 14, "task_id": 309, "numnodechanges": 358, "numwaychanges": 27 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317122, 47.602388 ], [ -122.31712, 47.603103 ], [ -122.317116, 47.603107 ], [ -122.316505, 47.603107 ], [ -122.31651, 47.602386 ], [ -122.317122, 47.602388 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14305", "project_id": 14, "task_id": 305, "numnodechanges": 18, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31469, 47.602219 ], [ -122.314566, 47.602449 ], [ -122.313573, 47.602522 ], [ -122.31353, 47.602394 ], [ -122.313531, 47.60233 ], [ -122.313734, 47.602143 ], [ -122.313981, 47.601994 ], [ -122.314416, 47.601966 ], [ -122.314657, 47.60217 ], [ -122.31469, 47.602219 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14236", "project_id": 14, "task_id": 236, "numnodechanges": 6, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316701, 47.599468 ], [ -122.317059, 47.599616 ], [ -122.317054, 47.600076 ], [ -122.316959, 47.600228 ], [ -122.31669, 47.600433 ], [ -122.316701, 47.599468 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1420", "project_id": 14, "task_id": 20, "numnodechanges": 121, "numwaychanges": 26 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321045, 47.596861 ], [ -122.321045, 47.596535 ], [ -122.321283, 47.596583 ], [ -122.322782, 47.597123 ], [ -122.322779, 47.597937 ], [ -122.321952, 47.597932 ], [ -122.321045, 47.596861 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1487", "project_id": 14, "task_id": 87, "numnodechanges": 144, "numwaychanges": 22 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320427, 47.605587 ], [ -122.320429, 47.604902 ], [ -122.320921, 47.604903 ], [ -122.321167, 47.60558 ], [ -122.320427, 47.605587 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14413", "project_id": 14, "task_id": 413, "numnodechanges": 23, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31762, 47.600779 ], [ -122.316663, 47.600489 ], [ -122.31669, 47.600433 ], [ -122.316959, 47.600228 ], [ -122.318146, 47.600498 ], [ -122.318153, 47.600572 ], [ -122.31762, 47.600779 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14310", "project_id": 14, "task_id": 310, "numnodechanges": 45, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316505, 47.603107 ], [ -122.316325, 47.603225 ], [ -122.315952, 47.603061 ], [ -122.315958, 47.602212 ], [ -122.316237, 47.602174 ], [ -122.316281, 47.60218 ], [ -122.31651, 47.602386 ], [ -122.316505, 47.603107 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14365", "project_id": 14, "task_id": 365, "numnodechanges": 8, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310958, 47.603297 ], [ -122.310732, 47.60295 ], [ -122.310747, 47.602917 ], [ -122.31142, 47.602917 ], [ -122.311916, 47.603241 ], [ -122.311426, 47.603315 ], [ -122.311113, 47.603317 ], [ -122.310958, 47.603297 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1496", "project_id": 14, "task_id": 96, "numnodechanges": 63, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308318, 47.603089 ], [ -122.308329, 47.603105 ], [ -122.308324, 47.603813 ], [ -122.308278, 47.603932 ], [ -122.307985, 47.603925 ], [ -122.307941, 47.603921 ], [ -122.307693, 47.603509 ], [ -122.307984, 47.603093 ], [ -122.308318, 47.603089 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14349", "project_id": 14, "task_id": 349, "numnodechanges": 225, "numwaychanges": 28 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321092, 47.606357 ], [ -122.320436, 47.606314 ], [ -122.320435, 47.606085 ], [ -122.321118, 47.606079 ], [ -122.321106, 47.606346 ], [ -122.321092, 47.606357 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14176", "project_id": 14, "task_id": 176, "numnodechanges": 64, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321222, 47.609483 ], [ -122.321019, 47.609994 ], [ -122.319273, 47.610351 ], [ -122.319259, 47.610352 ], [ -122.319086, 47.609515 ], [ -122.319118, 47.609491 ], [ -122.321222, 47.609483 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14196", "project_id": 14, "task_id": 196, "numnodechanges": 308, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309415, 47.599367 ], [ -122.308169, 47.59937 ], [ -122.308268, 47.599245 ], [ -122.308434, 47.599109 ], [ -122.309413, 47.599117 ], [ -122.309415, 47.599367 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1493", "project_id": 14, "task_id": 93, "numnodechanges": 9, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.307984, 47.603093 ], [ -122.307693, 47.603509 ], [ -122.307656, 47.603509 ], [ -122.307338, 47.603093 ], [ -122.307376, 47.60309 ], [ -122.307955, 47.603091 ], [ -122.307984, 47.603093 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14297", "project_id": 14, "task_id": 297, "numnodechanges": 24, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316569, 47.608157 ], [ -122.317423, 47.608154 ], [ -122.317453, 47.60835 ], [ -122.316655, 47.608353 ], [ -122.316569, 47.608157 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1456", "project_id": 14, "task_id": 56, "numnodechanges": 26, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308314, 47.604061 ], [ -122.308309, 47.605237 ], [ -122.308309, 47.605266 ], [ -122.308298, 47.605273 ], [ -122.308201, 47.605269 ], [ -122.307684, 47.60432 ], [ -122.307985, 47.603925 ], [ -122.308278, 47.603932 ], [ -122.308314, 47.604061 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14207", "project_id": 14, "task_id": 207, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316397, 47.609391 ], [ -122.316149, 47.609953 ], [ -122.315863, 47.609839 ], [ -122.31574, 47.609778 ], [ -122.315738, 47.608946 ], [ -122.316021, 47.608664 ], [ -122.316307, 47.608831 ], [ -122.3164, 47.60898 ], [ -122.316397, 47.609391 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1429", "project_id": 14, "task_id": 29, "numnodechanges": 7, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325423, 47.60274 ], [ -122.325104, 47.602526 ], [ -122.324867, 47.602201 ], [ -122.32487, 47.601069 ], [ -122.325363, 47.60087 ], [ -122.325497, 47.60087 ], [ -122.32603, 47.601294 ], [ -122.326028, 47.601975 ], [ -122.325543, 47.602786 ], [ -122.325423, 47.60274 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14128", "project_id": 14, "task_id": 128, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312203, 47.607393 ], [ -122.312535, 47.607714 ], [ -122.312532, 47.60859 ], [ -122.312462, 47.608631 ], [ -122.312167, 47.608628 ], [ -122.31217, 47.607426 ], [ -122.312203, 47.607393 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14180", "project_id": 14, "task_id": 180, "numnodechanges": 181, "numwaychanges": 21 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321226, 47.607506 ], [ -122.320676, 47.607517 ], [ -122.320481, 47.60702 ], [ -122.321072, 47.607025 ], [ -122.321216, 47.607364 ], [ -122.321226, 47.607506 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14268", "project_id": 14, "task_id": 268, "numnodechanges": 69, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321724, 47.608663 ], [ -122.31984, 47.608671 ], [ -122.320014, 47.608325 ], [ -122.321588, 47.608315 ], [ -122.321629, 47.608377 ], [ -122.321724, 47.608663 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14273", "project_id": 14, "task_id": 273, "numnodechanges": 349, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322554, 47.607303 ], [ -122.322625, 47.607471 ], [ -122.321629, 47.608377 ], [ -122.321588, 47.608315 ], [ -122.321449, 47.607923 ], [ -122.321437, 47.607796 ], [ -122.322172, 47.607145 ], [ -122.322429, 47.607184 ], [ -122.322554, 47.607303 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1472", "project_id": 14, "task_id": 72, "numnodechanges": 4, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324858, 47.60473 ], [ -122.325431, 47.604774 ], [ -122.325775, 47.605582 ], [ -122.325559, 47.60578 ], [ -122.325212, 47.605792 ], [ -122.324813, 47.604856 ], [ -122.324858, 47.60473 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14326", "project_id": 14, "task_id": 326, "numnodechanges": 6, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317783, 47.603943 ], [ -122.317779, 47.604781 ], [ -122.317113, 47.604781 ], [ -122.317109, 47.604778 ], [ -122.317117, 47.603939 ], [ -122.317782, 47.603942 ], [ -122.317783, 47.603943 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14109", "project_id": 14, "task_id": 109, "numnodechanges": 368, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311278, 47.599808 ], [ -122.312303, 47.599833 ], [ -122.312369, 47.599857 ], [ -122.31243, 47.600093 ], [ -122.311275, 47.600115 ], [ -122.311278, 47.599808 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14213", "project_id": 14, "task_id": 213, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313575, 47.603262 ], [ -122.31351, 47.603099 ], [ -122.313574, 47.602848 ], [ -122.314568, 47.602843 ], [ -122.314706, 47.60315 ], [ -122.31464, 47.603263 ], [ -122.313575, 47.603262 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14308", "project_id": 14, "task_id": 308, "numnodechanges": 176, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315585, 47.599508 ], [ -122.316096, 47.599182 ], [ -122.316027, 47.599545 ], [ -122.315792, 47.599977 ], [ -122.315388, 47.599936 ], [ -122.315585, 47.599508 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14100", "project_id": 14, "task_id": 100, "numnodechanges": 44, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313568, 47.59756 ], [ -122.312929, 47.598121 ], [ -122.312707, 47.597975 ], [ -122.312695, 47.597843 ], [ -122.313432, 47.597207 ], [ -122.31346, 47.597205 ], [ -122.313568, 47.59756 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14424", "project_id": 14, "task_id": 424, "numnodechanges": 18, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320794, 47.600009 ], [ -122.320331, 47.599883 ], [ -122.320332, 47.598766 ], [ -122.320543, 47.598417 ], [ -122.321503, 47.598907 ], [ -122.321497, 47.599861 ], [ -122.321167, 47.599969 ], [ -122.320794, 47.600009 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1427", "project_id": 14, "task_id": 27, "numnodechanges": 16, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325673, 47.602907 ], [ -122.325543, 47.602786 ], [ -122.326028, 47.601975 ], [ -122.326707, 47.601873 ], [ -122.32685, 47.602095 ], [ -122.325673, 47.602907 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14325", "project_id": 14, "task_id": 325, "numnodechanges": 210, "numwaychanges": 21 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318188, 47.605707 ], [ -122.318771, 47.605793 ], [ -122.318769, 47.606995 ], [ -122.318577, 47.607148 ], [ -122.31778, 47.607124 ], [ -122.317782, 47.60571 ], [ -122.318188, 47.605707 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14364", "project_id": 14, "task_id": 364, "numnodechanges": 12, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310752, 47.604094 ], [ -122.31047, 47.603932 ], [ -122.310472, 47.60312 ], [ -122.310474, 47.603094 ], [ -122.310732, 47.60295 ], [ -122.310958, 47.603297 ], [ -122.310958, 47.603948 ], [ -122.310752, 47.604094 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14263", "project_id": 14, "task_id": 263, "numnodechanges": 16, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318552, 47.602588 ], [ -122.318563, 47.603114 ], [ -122.318188, 47.603108 ], [ -122.318189, 47.602412 ], [ -122.318552, 47.602588 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14242", "project_id": 14, "task_id": 242, "numnodechanges": 7, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32331, 47.599563 ], [ -122.323195, 47.599656 ], [ -122.323191, 47.599658 ], [ -122.3232, 47.598762 ], [ -122.323426, 47.598692 ], [ -122.323548, 47.598753 ], [ -122.323544, 47.599197 ], [ -122.32349, 47.599385 ], [ -122.32331, 47.599563 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14142", "project_id": 14, "task_id": 142, "numnodechanges": 6, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311127, 47.600441 ], [ -122.312317, 47.600383 ], [ -122.312235, 47.600644 ], [ -122.310983, 47.600647 ], [ -122.311127, 47.600441 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1450", "project_id": 14, "task_id": 50, "numnodechanges": 28, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311437, 47.609348 ], [ -122.311224, 47.609272 ], [ -122.311189, 47.609252 ], [ -122.311192, 47.608752 ], [ -122.311535, 47.609208 ], [ -122.311437, 47.609348 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14446", "project_id": 14, "task_id": 446, "numnodechanges": 437, "numwaychanges": 27 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318784, 47.601249 ], [ -122.318505, 47.600842 ], [ -122.319967, 47.600328 ], [ -122.319994, 47.600841 ], [ -122.318784, 47.601249 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14107", "project_id": 14, "task_id": 107, "numnodechanges": 49, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313773, 47.598491 ], [ -122.313745, 47.597855 ], [ -122.314378, 47.597964 ], [ -122.314443, 47.598008 ], [ -122.314441, 47.59872 ], [ -122.314274, 47.598742 ], [ -122.314046, 47.598691 ], [ -122.313773, 47.598491 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14116", "project_id": 14, "task_id": 116, "numnodechanges": 14, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311535, 47.609208 ], [ -122.311563, 47.609209 ], [ -122.311695, 47.609441 ], [ -122.311437, 47.609348 ], [ -122.311535, 47.609208 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1426", "project_id": 14, "task_id": 26, "numnodechanges": 248, "numwaychanges": 22 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326226, 47.604395 ], [ -122.326533, 47.605129 ], [ -122.326098, 47.605523 ], [ -122.325775, 47.605582 ], [ -122.325431, 47.604774 ], [ -122.326226, 47.604395 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14440", "project_id": 14, "task_id": 440, "numnodechanges": 379, "numwaychanges": 31 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319318, 47.602166 ], [ -122.319748, 47.602231 ], [ -122.319745, 47.603114 ], [ -122.319705, 47.603144 ], [ -122.319252, 47.603109 ], [ -122.319318, 47.602166 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14318", "project_id": 14, "task_id": 318, "numnodechanges": 54, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321266, 47.603649 ], [ -122.321506, 47.604203 ], [ -122.321527, 47.604415 ], [ -122.32136, 47.604576 ], [ -122.321266, 47.604585 ], [ -122.321021, 47.604405 ], [ -122.32088, 47.603878 ], [ -122.321266, 47.603649 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14410", "project_id": 14, "task_id": 410, "numnodechanges": 135, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317763, 47.599771 ], [ -122.317757, 47.5988 ], [ -122.317967, 47.598753 ], [ -122.318394, 47.598841 ], [ -122.318438, 47.598875 ], [ -122.318447, 47.599806 ], [ -122.318165, 47.600138 ], [ -122.317763, 47.599771 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14114", "project_id": 14, "task_id": 114, "numnodechanges": 2, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315863, 47.609839 ], [ -122.315488, 47.610378 ], [ -122.315089, 47.610351 ], [ -122.314426, 47.610216 ], [ -122.314813, 47.609767 ], [ -122.31574, 47.609778 ], [ -122.315863, 47.609839 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14322", "project_id": 14, "task_id": 322, "numnodechanges": 222, "numwaychanges": 20 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32346, 47.606354 ], [ -122.323333, 47.606052 ], [ -122.32366, 47.605752 ], [ -122.323788, 47.606061 ], [ -122.32346, 47.606354 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14431", "project_id": 14, "task_id": 431, "numnodechanges": 19, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317236, 47.605792 ], [ -122.31711, 47.606035 ], [ -122.316541, 47.606037 ], [ -122.316542, 47.605793 ], [ -122.317236, 47.605792 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14439", "project_id": 14, "task_id": 439, "numnodechanges": 185, "numwaychanges": 19 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318992, 47.603175 ], [ -122.318987, 47.602157 ], [ -122.319049, 47.602047 ], [ -122.319318, 47.602166 ], [ -122.319252, 47.603109 ], [ -122.318992, 47.603175 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14432", "project_id": 14, "task_id": 432, "numnodechanges": 0, "numwaychanges": 0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316542, 47.605793 ], [ -122.316541, 47.606037 ], [ -122.316506, 47.606085 ], [ -122.316153, 47.606009 ], [ -122.315891, 47.605828 ], [ -122.315891, 47.605717 ], [ -122.316519, 47.60572 ], [ -122.316542, 47.605793 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14204", "project_id": 14, "task_id": 204, "numnodechanges": 12, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310747, 47.599437 ], [ -122.310741, 47.598549 ], [ -122.310965, 47.598632 ], [ -122.311216, 47.598859 ], [ -122.311394, 47.599068 ], [ -122.311395, 47.599422 ], [ -122.311172, 47.599646 ], [ -122.310785, 47.599531 ], [ -122.310747, 47.599437 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14257", "project_id": 14, "task_id": 257, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314638, 47.603942 ], [ -122.31464, 47.603263 ], [ -122.314706, 47.60315 ], [ -122.315299, 47.60305 ], [ -122.315472, 47.603174 ], [ -122.31547, 47.604507 ], [ -122.315222, 47.604556 ], [ -122.314638, 47.603942 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1417", "project_id": 14, "task_id": 17, "numnodechanges": 34, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320543, 47.598224 ], [ -122.319307, 47.59822 ], [ -122.319138, 47.597794 ], [ -122.320603, 47.597809 ], [ -122.320543, 47.598224 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14264", "project_id": 14, "task_id": 264, "numnodechanges": 30, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318189, 47.602412 ], [ -122.318188, 47.603108 ], [ -122.318182, 47.603109 ], [ -122.317785, 47.603111 ], [ -122.317787, 47.602355 ], [ -122.318129, 47.602358 ], [ -122.318189, 47.602412 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14314", "project_id": 14, "task_id": 314, "numnodechanges": 147, "numwaychanges": 26 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323261, 47.600975 ], [ -122.323256, 47.601947 ], [ -122.322018, 47.601945 ], [ -122.322015, 47.601366 ], [ -122.322796, 47.60063 ], [ -122.323261, 47.600975 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14181", "project_id": 14, "task_id": 181, "numnodechanges": 194, "numwaychanges": 15 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313424, 47.598383 ], [ -122.313035, 47.598665 ], [ -122.313036, 47.598311 ], [ -122.31346, 47.598106 ], [ -122.313424, 47.598383 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14415", "project_id": 14, "task_id": 415, "numnodechanges": 121, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318505, 47.600842 ], [ -122.318444, 47.600803 ], [ -122.319614, 47.599806 ], [ -122.320097, 47.600019 ], [ -122.319967, 47.600328 ], [ -122.318505, 47.600842 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14191", "project_id": 14, "task_id": 191, "numnodechanges": 12, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311725, 47.599418 ], [ -122.312303, 47.599833 ], [ -122.311278, 47.599808 ], [ -122.311172, 47.599646 ], [ -122.311395, 47.599422 ], [ -122.311725, 47.599418 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1457", "project_id": 14, "task_id": 57, "numnodechanges": 46, "numwaychanges": 12 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309614, 47.605154 ], [ -122.309493, 47.605194 ], [ -122.308965, 47.60433 ], [ -122.3091, 47.60414 ], [ -122.309615, 47.604075 ], [ -122.309614, 47.605154 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14117", "project_id": 14, "task_id": 117, "numnodechanges": 163, "numwaychanges": 26 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312532, 47.60859 ], [ -122.312535, 47.607714 ], [ -122.313515, 47.607709 ], [ -122.313513, 47.60846 ], [ -122.313183, 47.608593 ], [ -122.312532, 47.60859 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14232", "project_id": 14, "task_id": 232, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314499, 47.599216 ], [ -122.314496, 47.598765 ], [ -122.314959, 47.598767 ], [ -122.315055, 47.599349 ], [ -122.315054, 47.599357 ], [ -122.314862, 47.599383 ], [ -122.314499, 47.599216 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14296", "project_id": 14, "task_id": 296, "numnodechanges": 9, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313226, 47.603932 ], [ -122.313187, 47.603934 ], [ -122.312621, 47.603928 ], [ -122.312867, 47.603519 ], [ -122.312899, 47.603517 ], [ -122.313226, 47.603932 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14300", "project_id": 14, "task_id": 300, "numnodechanges": 6, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316166, 47.608375 ], [ -122.316169, 47.607426 ], [ -122.316516, 47.607823 ], [ -122.316515, 47.60811 ], [ -122.316166, 47.608375 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1434", "project_id": 14, "task_id": 34, "numnodechanges": 160, "numwaychanges": 21 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325363, 47.60087 ], [ -122.32487, 47.601069 ], [ -122.324713, 47.600975 ], [ -122.324716, 47.599931 ], [ -122.325366, 47.599935 ], [ -122.325363, 47.60087 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14278", "project_id": 14, "task_id": 278, "numnodechanges": 15, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311447, 47.597726 ], [ -122.311199, 47.597762 ], [ -122.311199, 47.597266 ], [ -122.311226, 47.597251 ], [ -122.311344, 47.597209 ], [ -122.311587, 47.597493 ], [ -122.311447, 47.597726 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14194", "project_id": 14, "task_id": 194, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.307825, 47.599804 ], [ -122.308019, 47.599559 ], [ -122.309464, 47.599542 ], [ -122.309572, 47.599808 ], [ -122.307825, 47.599804 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14367", "project_id": 14, "task_id": 367, "numnodechanges": 278, "numwaychanges": 22 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312204, 47.603095 ], [ -122.312076, 47.603287 ], [ -122.311916, 47.603241 ], [ -122.31142, 47.602917 ], [ -122.311419, 47.602466 ], [ -122.312202, 47.602482 ], [ -122.312204, 47.603095 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1418", "project_id": 14, "task_id": 18, "numnodechanges": 322, "numwaychanges": 19 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319138, 47.597794 ], [ -122.318814, 47.597543 ], [ -122.318438, 47.597097 ], [ -122.318592, 47.596653 ], [ -122.318789, 47.59614 ], [ -122.319272, 47.596172 ], [ -122.321045, 47.596535 ], [ -122.321045, 47.596861 ], [ -122.320603, 47.597809 ], [ -122.319138, 47.597794 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14447", "project_id": 14, "task_id": 447, "numnodechanges": 60, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319967, 47.600328 ], [ -122.320097, 47.600019 ], [ -122.320331, 47.599883 ], [ -122.320794, 47.600009 ], [ -122.320891, 47.600802 ], [ -122.320885, 47.60122 ], [ -122.320173, 47.601367 ], [ -122.320138, 47.601326 ], [ -122.319994, 47.600841 ], [ -122.319967, 47.600328 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14448", "project_id": 14, "task_id": 448, "numnodechanges": 94, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319381, 47.603955 ], [ -122.319718, 47.603931 ], [ -122.319741, 47.603949 ], [ -122.31974, 47.604788 ], [ -122.319378, 47.60479 ], [ -122.319381, 47.603955 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14306", "project_id": 14, "task_id": 306, "numnodechanges": 24, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315304, 47.600865 ], [ -122.315887, 47.600862 ], [ -122.315886, 47.602182 ], [ -122.315357, 47.60218 ], [ -122.315306, 47.60173 ], [ -122.315304, 47.600865 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14354", "project_id": 14, "task_id": 354, "numnodechanges": 44, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321118, 47.606079 ], [ -122.320435, 47.606085 ], [ -122.320301, 47.605711 ], [ -122.320427, 47.605587 ], [ -122.321167, 47.60558 ], [ -122.321303, 47.605645 ], [ -122.321306, 47.605663 ], [ -122.321118, 47.606079 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14144", "project_id": 14, "task_id": 144, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309872, 47.602093 ], [ -122.309609, 47.602347 ], [ -122.309348, 47.602158 ], [ -122.30935, 47.601264 ], [ -122.309588, 47.601042 ], [ -122.309875, 47.601206 ], [ -122.309872, 47.602093 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14173", "project_id": 14, "task_id": 173, "numnodechanges": 44, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31984, 47.608671 ], [ -122.321724, 47.608663 ], [ -122.321823, 47.608851 ], [ -122.32186, 47.609008 ], [ -122.321832, 47.609022 ], [ -122.31958, 47.609034 ], [ -122.31984, 47.608671 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14395", "project_id": 14, "task_id": 395, "numnodechanges": 1, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314826, 47.606042 ], [ -122.313511, 47.606011 ], [ -122.313431, 47.605694 ], [ -122.314828, 47.605724 ], [ -122.314827, 47.606037 ], [ -122.314826, 47.606042 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14151", "project_id": 14, "task_id": 151, "numnodechanges": 23, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315902, 47.598996 ], [ -122.315909, 47.59792 ], [ -122.316092, 47.597918 ], [ -122.316088, 47.599144 ], [ -122.315902, 47.598996 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14122", "project_id": 14, "task_id": 122, "numnodechanges": 0, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312841, 47.609214 ], [ -122.312869, 47.609214 ], [ -122.313119, 47.609597 ], [ -122.313145, 47.609953 ], [ -122.313078, 47.60994 ], [ -122.3125, 47.609731 ], [ -122.3125, 47.609718 ], [ -122.312841, 47.609214 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14304", "project_id": 14, "task_id": 304, "numnodechanges": 3, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316569, 47.608157 ], [ -122.316655, 47.608353 ], [ -122.3166, 47.608592 ], [ -122.316307, 47.608831 ], [ -122.316021, 47.608664 ], [ -122.315999, 47.608585 ], [ -122.316166, 47.608375 ], [ -122.316515, 47.60811 ], [ -122.316569, 47.608157 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1458", "project_id": 14, "task_id": 58, "numnodechanges": 37, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316971, 47.610476 ], [ -122.316164, 47.610423 ], [ -122.316163, 47.609975 ], [ -122.316972, 47.609978 ], [ -122.316971, 47.610476 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14418", "project_id": 14, "task_id": 418, "numnodechanges": 0, "numwaychanges": 0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321497, 47.599861 ], [ -122.322196, 47.600077 ], [ -122.322282, 47.600131 ], [ -122.321632, 47.600759 ], [ -122.321367, 47.600759 ], [ -122.321167, 47.599969 ], [ -122.321497, 47.599861 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14337", "project_id": 14, "task_id": 337, "numnodechanges": 313, "numwaychanges": 19 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316882, 47.601604 ], [ -122.317095, 47.601863 ], [ -122.317094, 47.601882 ], [ -122.316581, 47.60188 ], [ -122.316581, 47.601584 ], [ -122.316882, 47.601604 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14341", "project_id": 14, "task_id": 341, "numnodechanges": 17, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317595, 47.602188 ], [ -122.317617, 47.602138 ], [ -122.317954, 47.601862 ], [ -122.318122, 47.601977 ], [ -122.31778, 47.602349 ], [ -122.317595, 47.602188 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14255", "project_id": 14, "task_id": 255, "numnodechanges": 80, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318187, 47.603943 ], [ -122.318182, 47.603109 ], [ -122.318188, 47.603108 ], [ -122.318563, 47.603114 ], [ -122.31881, 47.603286 ], [ -122.3188, 47.603941 ], [ -122.318191, 47.603943 ], [ -122.318187, 47.603943 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14444", "project_id": 14, "task_id": 444, "numnodechanges": 748, "numwaychanges": 26 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320173, 47.601367 ], [ -122.320168, 47.602029 ], [ -122.319748, 47.602231 ], [ -122.319318, 47.602166 ], [ -122.319049, 47.602047 ], [ -122.318904, 47.601781 ], [ -122.318901, 47.601521 ], [ -122.320138, 47.601326 ], [ -122.320173, 47.601367 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14101", "project_id": 14, "task_id": 101, "numnodechanges": 151, "numwaychanges": 19 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313487, 47.597167 ], [ -122.313486, 47.5965 ], [ -122.314935, 47.596204 ], [ -122.314936, 47.596672 ], [ -122.314377, 47.59703 ], [ -122.313487, 47.597167 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14139", "project_id": 14, "task_id": 139, "numnodechanges": 15, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317254, 47.610485 ], [ -122.317181, 47.61049 ], [ -122.316971, 47.610476 ], [ -122.316972, 47.609978 ], [ -122.317255, 47.60985 ], [ -122.317254, 47.610485 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14157", "project_id": 14, "task_id": 157, "numnodechanges": 4, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3232, 47.598762 ], [ -122.322866, 47.598729 ], [ -122.322779, 47.598608 ], [ -122.322781, 47.597939 ], [ -122.323426, 47.597936 ], [ -122.323428, 47.597937 ], [ -122.323426, 47.598692 ], [ -122.3232, 47.598762 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14338", "project_id": 14, "task_id": 338, "numnodechanges": 67, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316948, 47.601345 ], [ -122.317181, 47.601269 ], [ -122.317194, 47.601611 ], [ -122.317095, 47.601863 ], [ -122.316882, 47.601604 ], [ -122.316885, 47.601488 ], [ -122.316948, 47.601345 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14443", "project_id": 14, "task_id": 443, "numnodechanges": 219, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320138, 47.601326 ], [ -122.318901, 47.601521 ], [ -122.318784, 47.601249 ], [ -122.319994, 47.600841 ], [ -122.320138, 47.601326 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14289", "project_id": 14, "task_id": 289, "numnodechanges": 4, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309907, 47.602076 ], [ -122.310144, 47.601803 ], [ -122.310931, 47.601813 ], [ -122.310945, 47.601896 ], [ -122.310921, 47.602091 ], [ -122.309907, 47.602076 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1469", "project_id": 14, "task_id": 69, "numnodechanges": 2, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321503, 47.598907 ], [ -122.320543, 47.598417 ], [ -122.320543, 47.598224 ], [ -122.320603, 47.597809 ], [ -122.321045, 47.596861 ], [ -122.321952, 47.597932 ], [ -122.32195, 47.598598 ], [ -122.321924, 47.59865 ], [ -122.321503, 47.598907 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1467", "project_id": 14, "task_id": 67, "numnodechanges": 10, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322781, 47.597939 ], [ -122.322779, 47.597937 ], [ -122.322782, 47.597123 ], [ -122.323137, 47.597251 ], [ -122.323428, 47.597412 ], [ -122.323426, 47.597936 ], [ -122.322781, 47.597939 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14158", "project_id": 14, "task_id": 158, "numnodechanges": 244, "numwaychanges": 27 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323428, 47.597937 ], [ -122.323952, 47.59794 ], [ -122.324077, 47.598143 ], [ -122.324075, 47.598756 ], [ -122.323548, 47.598753 ], [ -122.323426, 47.598692 ], [ -122.323428, 47.597937 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14402", "project_id": 14, "task_id": 402, "numnodechanges": 55, "numwaychanges": 14 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31353, 47.602394 ], [ -122.313573, 47.602522 ], [ -122.313574, 47.602848 ], [ -122.31351, 47.603099 ], [ -122.313154, 47.603098 ], [ -122.312904, 47.602681 ], [ -122.313071, 47.602455 ], [ -122.31353, 47.602394 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1422", "project_id": 14, "task_id": 22, "numnodechanges": 188, "numwaychanges": 19 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32597, 47.606505 ], [ -122.326224, 47.607115 ], [ -122.326096, 47.607277 ], [ -122.325914, 47.607427 ], [ -122.325624, 47.60673 ], [ -122.325868, 47.606509 ], [ -122.32597, 47.606505 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14357", "project_id": 14, "task_id": 357, "numnodechanges": 81, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32184, 47.606404 ], [ -122.3223, 47.606352 ], [ -122.322519, 47.606886 ], [ -122.322429, 47.607184 ], [ -122.322172, 47.607145 ], [ -122.321832, 47.606782 ], [ -122.321812, 47.606736 ], [ -122.321826, 47.606435 ], [ -122.32184, 47.606404 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14141", "project_id": 14, "task_id": 141, "numnodechanges": 307, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312232, 47.601276 ], [ -122.310968, 47.601269 ], [ -122.310971, 47.600656 ], [ -122.310983, 47.600647 ], [ -122.312235, 47.600644 ], [ -122.312235, 47.60127 ], [ -122.312232, 47.601276 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14169", "project_id": 14, "task_id": 169, "numnodechanges": 339, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32451, 47.607201 ], [ -122.324736, 47.606998 ], [ -122.325069, 47.606965 ], [ -122.325428, 47.607826 ], [ -122.325024, 47.608158 ], [ -122.324886, 47.608104 ], [ -122.32451, 47.607201 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14358", "project_id": 14, "task_id": 358, "numnodechanges": 341, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321812, 47.606736 ], [ -122.321832, 47.606782 ], [ -122.321216, 47.607364 ], [ -122.321072, 47.607025 ], [ -122.321072, 47.607024 ], [ -122.32135, 47.60677 ], [ -122.321812, 47.606736 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14379", "project_id": 14, "task_id": 379, "numnodechanges": 4, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31511, 47.59943 ], [ -122.315054, 47.599357 ], [ -122.315055, 47.599349 ], [ -122.315671, 47.598869 ], [ -122.315902, 47.598996 ], [ -122.316088, 47.599144 ], [ -122.316109, 47.599164 ], [ -122.316096, 47.599182 ], [ -122.315585, 47.599508 ], [ -122.315287, 47.599471 ], [ -122.31511, 47.59943 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14293", "project_id": 14, "task_id": 293, "numnodechanges": 128, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312231, 47.601886 ], [ -122.312232, 47.601276 ], [ -122.312235, 47.60127 ], [ -122.313055, 47.601272 ], [ -122.313265, 47.601357 ], [ -122.313263, 47.601977 ], [ -122.312261, 47.601981 ], [ -122.312231, 47.601886 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1448", "project_id": 14, "task_id": 48, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309355, 47.606602 ], [ -122.308315, 47.606596 ], [ -122.308279, 47.606373 ], [ -122.308291, 47.606288 ], [ -122.309278, 47.606314 ], [ -122.309355, 47.606602 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1465", "project_id": 14, "task_id": 65, "numnodechanges": 69, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323426, 47.597936 ], [ -122.323428, 47.597412 ], [ -122.324062, 47.597763 ], [ -122.323952, 47.59794 ], [ -122.323428, 47.597937 ], [ -122.323426, 47.597936 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14131", "project_id": 14, "task_id": 131, "numnodechanges": 281, "numwaychanges": 21 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309929, 47.605262 ], [ -122.310747, 47.605248 ], [ -122.310917, 47.605341 ], [ -122.31091, 47.606774 ], [ -122.310614, 47.607094 ], [ -122.310559, 47.607112 ], [ -122.309941, 47.607105 ], [ -122.309931, 47.607101 ], [ -122.309929, 47.605262 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14313", "project_id": 14, "task_id": 313, "numnodechanges": 271, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319423, 47.598772 ], [ -122.319306, 47.598714 ], [ -122.319307, 47.59822 ], [ -122.320543, 47.598224 ], [ -122.320543, 47.598417 ], [ -122.320332, 47.598766 ], [ -122.319423, 47.598772 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1492", "project_id": 14, "task_id": 92, "numnodechanges": 2, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309226, 47.603103 ], [ -122.309267, 47.603106 ], [ -122.308974, 47.603522 ], [ -122.308947, 47.603521 ], [ -122.308656, 47.603103 ], [ -122.30866, 47.603103 ], [ -122.309226, 47.603103 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14252", "project_id": 14, "task_id": 252, "numnodechanges": 294, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324316, 47.605308 ], [ -122.324813, 47.604856 ], [ -122.325212, 47.605792 ], [ -122.32497, 47.606016 ], [ -122.32476, 47.606039 ], [ -122.32446, 47.605655 ], [ -122.324316, 47.605308 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1432", "project_id": 14, "task_id": 32, "numnodechanges": 26, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324716, 47.599931 ], [ -122.324666, 47.599763 ], [ -122.325413, 47.599768 ], [ -122.325366, 47.599935 ], [ -122.324716, 47.599931 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14249", "project_id": 14, "task_id": 249, "numnodechanges": 87, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322444, 47.603916 ], [ -122.322394, 47.604057 ], [ -122.321965, 47.604448 ], [ -122.321527, 47.604415 ], [ -122.321506, 47.604203 ], [ -122.322225, 47.603593 ], [ -122.322444, 47.603916 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14442", "project_id": 14, "task_id": 442, "numnodechanges": 125, "numwaychanges": 16 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31881, 47.603286 ], [ -122.318563, 47.603114 ], [ -122.318552, 47.602588 ], [ -122.318987, 47.602157 ], [ -122.318992, 47.603175 ], [ -122.31881, 47.603286 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14449", "project_id": 14, "task_id": 449, "numnodechanges": 112, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319373, 47.604791 ], [ -122.318797, 47.604777 ], [ -122.318803, 47.603944 ], [ -122.319381, 47.603955 ], [ -122.319378, 47.60479 ], [ -122.319373, 47.604791 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14298", "project_id": 14, "task_id": 298, "numnodechanges": 49, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317423, 47.608154 ], [ -122.317423, 47.607817 ], [ -122.317591, 47.60736 ], [ -122.317752, 47.607133 ], [ -122.31778, 47.607124 ], [ -122.318577, 47.607148 ], [ -122.319023, 47.609471 ], [ -122.317994, 47.609263 ], [ -122.317732, 47.608976 ], [ -122.317527, 47.60859 ], [ -122.317453, 47.60835 ], [ -122.317423, 47.608154 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14414", "project_id": 14, "task_id": 414, "numnodechanges": 119, "numwaychanges": 15 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318038, 47.601203 ], [ -122.317628, 47.601638 ], [ -122.317544, 47.601594 ], [ -122.317301, 47.601111 ], [ -122.31762, 47.600779 ], [ -122.318153, 47.600572 ], [ -122.318246, 47.600688 ], [ -122.318038, 47.601203 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14266", "project_id": 14, "task_id": 266, "numnodechanges": 97, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323104, 47.606971 ], [ -122.323296, 47.607443 ], [ -122.323081, 47.607732 ], [ -122.322937, 47.607785 ], [ -122.322625, 47.607471 ], [ -122.322554, 47.607303 ], [ -122.323104, 47.606971 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14172", "project_id": 14, "task_id": 172, "numnodechanges": 22, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325069, 47.606965 ], [ -122.325284, 47.606767 ], [ -122.325624, 47.60673 ], [ -122.325914, 47.607427 ], [ -122.325428, 47.607826 ], [ -122.325069, 47.606965 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14408", "project_id": 14, "task_id": 408, "numnodechanges": 50, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318992, 47.598775 ], [ -122.319146, 47.598757 ], [ -122.319146, 47.59968 ], [ -122.318992, 47.599686 ], [ -122.318992, 47.598775 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14174", "project_id": 14, "task_id": 174, "numnodechanges": 35, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320422, 47.606981 ], [ -122.320481, 47.60702 ], [ -122.320676, 47.607517 ], [ -122.320135, 47.607998 ], [ -122.320083, 47.608025 ], [ -122.319983, 47.607784 ], [ -122.320422, 47.606981 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14203", "project_id": 14, "task_id": 203, "numnodechanges": 306, "numwaychanges": 26 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310152, 47.599417 ], [ -122.310154, 47.598229 ], [ -122.310623, 47.598385 ], [ -122.310741, 47.598549 ], [ -122.310747, 47.599437 ], [ -122.310152, 47.599417 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14330", "project_id": 14, "task_id": 330, "numnodechanges": 132, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315753, 47.604562 ], [ -122.316325, 47.603936 ], [ -122.317116, 47.603938 ], [ -122.317117, 47.603939 ], [ -122.317109, 47.604778 ], [ -122.316054, 47.604775 ], [ -122.315894, 47.604713 ], [ -122.315753, 47.604562 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14129", "project_id": 14, "task_id": 129, "numnodechanges": 57, "numwaychanges": 15 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312298, 47.605274 ], [ -122.312211, 47.605275 ], [ -122.312193, 47.605263 ], [ -122.312199, 47.603935 ], [ -122.312519, 47.603934 ], [ -122.312866, 47.604342 ], [ -122.312298, 47.605274 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14220", "project_id": 14, "task_id": 220, "numnodechanges": 6, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31047, 47.603932 ], [ -122.309855, 47.603964 ], [ -122.310178, 47.60352 ], [ -122.310207, 47.603521 ], [ -122.31047, 47.603932 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14409", "project_id": 14, "task_id": 409, "numnodechanges": 139, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318438, 47.598875 ], [ -122.31881, 47.598757 ], [ -122.318992, 47.598775 ], [ -122.318992, 47.599686 ], [ -122.318447, 47.599806 ], [ -122.318438, 47.598875 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14422", "project_id": 14, "task_id": 422, "numnodechanges": 80, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322196, 47.600077 ], [ -122.322207, 47.599105 ], [ -122.322731, 47.599105 ], [ -122.322832, 47.600011 ], [ -122.322653, 47.600293 ], [ -122.322282, 47.600131 ], [ -122.322196, 47.600077 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14396", "project_id": 14, "task_id": 396, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314827, 47.606037 ], [ -122.314828, 47.605724 ], [ -122.314829, 47.605721 ], [ -122.315889, 47.605712 ], [ -122.315891, 47.605717 ], [ -122.315891, 47.605828 ], [ -122.315775, 47.606028 ], [ -122.314827, 47.606037 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14182", "project_id": 14, "task_id": 182, "numnodechanges": 60, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313035, 47.598665 ], [ -122.312981, 47.598954 ], [ -122.312605, 47.599077 ], [ -122.312204, 47.598696 ], [ -122.312193, 47.59867 ], [ -122.312192, 47.598411 ], [ -122.312707, 47.597975 ], [ -122.312929, 47.598121 ], [ -122.313036, 47.598311 ], [ -122.313035, 47.598665 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1491", "project_id": 14, "task_id": 91, "numnodechanges": 39, "numwaychanges": 7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308656, 47.603103 ], [ -122.308329, 47.603105 ], [ -122.308318, 47.603089 ], [ -122.30832, 47.60215 ], [ -122.308511, 47.60216 ], [ -122.308946, 47.602681 ], [ -122.30866, 47.603103 ], [ -122.308656, 47.603103 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14271", "project_id": 14, "task_id": 271, "numnodechanges": 0, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321437, 47.607796 ], [ -122.321226, 47.607506 ], [ -122.321216, 47.607364 ], [ -122.321832, 47.606782 ], [ -122.322172, 47.607145 ], [ -122.321437, 47.607796 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14118", "project_id": 14, "task_id": 118, "numnodechanges": 23, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313183, 47.608593 ], [ -122.313513, 47.60846 ], [ -122.313746, 47.608628 ], [ -122.313744, 47.610076 ], [ -122.313145, 47.609953 ], [ -122.313119, 47.609597 ], [ -122.313118, 47.608998 ], [ -122.313183, 47.608593 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14244", "project_id": 14, "task_id": 244, "numnodechanges": 24, "numwaychanges": 15 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32349, 47.599385 ], [ -122.323544, 47.599197 ], [ -122.324069, 47.5992 ], [ -122.324086, 47.599389 ], [ -122.32349, 47.599385 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14380", "project_id": 14, "task_id": 380, "numnodechanges": 170, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315287, 47.599471 ], [ -122.315585, 47.599508 ], [ -122.315388, 47.599936 ], [ -122.315157, 47.600206 ], [ -122.31507, 47.600061 ], [ -122.315287, 47.599471 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14167", "project_id": 14, "task_id": 167, "numnodechanges": 190, "numwaychanges": 23 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322904, 47.605795 ], [ -122.322886, 47.605796 ], [ -122.322573, 47.605046 ], [ -122.322743, 47.604889 ], [ -122.323117, 47.604808 ], [ -122.323356, 47.605382 ], [ -122.322904, 47.605795 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1461", "project_id": 14, "task_id": 61, "numnodechanges": 34, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315671, 47.598869 ], [ -122.31543, 47.598692 ], [ -122.315434, 47.597799 ], [ -122.315909, 47.59792 ], [ -122.315902, 47.598996 ], [ -122.315671, 47.598869 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14376", "project_id": 14, "task_id": 376, "numnodechanges": 184, "numwaychanges": 15 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315145, 47.600772 ], [ -122.315157, 47.600206 ], [ -122.315388, 47.599936 ], [ -122.315792, 47.599977 ], [ -122.315897, 47.600859 ], [ -122.315887, 47.600862 ], [ -122.315304, 47.600865 ], [ -122.315243, 47.600837 ], [ -122.315145, 47.600772 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1495", "project_id": 14, "task_id": 95, "numnodechanges": 0, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.307941, 47.603921 ], [ -122.307388, 47.603918 ], [ -122.307656, 47.603509 ], [ -122.307693, 47.603509 ], [ -122.307941, 47.603921 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14342", "project_id": 14, "task_id": 342, "numnodechanges": 8, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317954, 47.601862 ], [ -122.318043, 47.601755 ], [ -122.318457, 47.601956 ], [ -122.318433, 47.601978 ], [ -122.318122, 47.601977 ], [ -122.317954, 47.601862 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14237", "project_id": 14, "task_id": 237, "numnodechanges": 58, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31625, 47.600721 ], [ -122.316472, 47.599261 ], [ -122.316701, 47.599468 ], [ -122.31669, 47.600433 ], [ -122.316663, 47.600489 ], [ -122.31625, 47.600721 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14323", "project_id": 14, "task_id": 323, "numnodechanges": 8, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319745, 47.604792 ], [ -122.320312, 47.604791 ], [ -122.320359, 47.604821 ], [ -122.320429, 47.604902 ], [ -122.320427, 47.605587 ], [ -122.320301, 47.605711 ], [ -122.319747, 47.605714 ], [ -122.319743, 47.605712 ], [ -122.319745, 47.604792 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14113", "project_id": 14, "task_id": 113, "numnodechanges": 164, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314813, 47.609767 ], [ -122.314815, 47.608947 ], [ -122.315738, 47.608946 ], [ -122.31574, 47.609778 ], [ -122.314813, 47.609767 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14106", "project_id": 14, "task_id": 106, "numnodechanges": 106, "numwaychanges": 16 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313658, 47.598993 ], [ -122.313133, 47.598964 ], [ -122.313709, 47.598518 ], [ -122.313773, 47.598491 ], [ -122.314046, 47.598691 ], [ -122.313658, 47.598993 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14267", "project_id": 14, "task_id": 267, "numnodechanges": 142, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322625, 47.607471 ], [ -122.322937, 47.607785 ], [ -122.322935, 47.607825 ], [ -122.321823, 47.608851 ], [ -122.321724, 47.608663 ], [ -122.321629, 47.608377 ], [ -122.322625, 47.607471 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14123", "project_id": 14, "task_id": 123, "numnodechanges": 1, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312462, 47.608631 ], [ -122.312532, 47.60859 ], [ -122.313183, 47.608593 ], [ -122.313118, 47.608998 ], [ -122.312909, 47.609154 ], [ -122.312803, 47.609162 ], [ -122.312502, 47.608975 ], [ -122.312462, 47.608631 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14329", "project_id": 14, "task_id": 329, "numnodechanges": 103, "numwaychanges": 14 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317784, 47.603112 ], [ -122.317785, 47.603111 ], [ -122.318182, 47.603109 ], [ -122.318187, 47.603943 ], [ -122.317783, 47.603943 ], [ -122.317782, 47.603942 ], [ -122.317784, 47.603112 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14279", "project_id": 14, "task_id": 279, "numnodechanges": 2, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311344, 47.597209 ], [ -122.312031, 47.596961 ], [ -122.311625, 47.597493 ], [ -122.311587, 47.597493 ], [ -122.311344, 47.597209 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14188", "project_id": 14, "task_id": 188, "numnodechanges": 130, "numwaychanges": 12 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311772, 47.598102 ], [ -122.311981, 47.598069 ], [ -122.312192, 47.598411 ], [ -122.312193, 47.59867 ], [ -122.311769, 47.598597 ], [ -122.311617, 47.598333 ], [ -122.311772, 47.598102 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14344", "project_id": 14, "task_id": 344, "numnodechanges": 9, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318122, 47.601977 ], [ -122.318433, 47.601978 ], [ -122.318129, 47.602358 ], [ -122.317787, 47.602355 ], [ -122.31778, 47.602349 ], [ -122.318122, 47.601977 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14120", "project_id": 14, "task_id": 120, "numnodechanges": 38, "numwaychanges": 12 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312803, 47.609162 ], [ -122.312841, 47.609214 ], [ -122.3125, 47.609718 ], [ -122.312502, 47.608975 ], [ -122.312803, 47.609162 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14262", "project_id": 14, "task_id": 262, "numnodechanges": 159, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316239, 47.601053 ], [ -122.316101, 47.600839 ], [ -122.31616, 47.600791 ], [ -122.316179, 47.600781 ], [ -122.317256, 47.601142 ], [ -122.317181, 47.601269 ], [ -122.316948, 47.601345 ], [ -122.316389, 47.601202 ], [ -122.316239, 47.601053 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1416", "project_id": 14, "task_id": 16, "numnodechanges": 242, "numwaychanges": 23 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316785, 47.597921 ], [ -122.316621, 47.597745 ], [ -122.316621, 47.597081 ], [ -122.318432, 47.597102 ], [ -122.318401, 47.597155 ], [ -122.317972, 47.597621 ], [ -122.317511, 47.597921 ], [ -122.316785, 47.597921 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14185", "project_id": 14, "task_id": 185, "numnodechanges": 268, "numwaychanges": 14 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313732, 47.597844 ], [ -122.313745, 47.597855 ], [ -122.313773, 47.598491 ], [ -122.313709, 47.598518 ], [ -122.313424, 47.598383 ], [ -122.31346, 47.598106 ], [ -122.313732, 47.597844 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14258", "project_id": 14, "task_id": 258, "numnodechanges": 93, "numwaychanges": 17 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313561, 47.604955 ], [ -122.313568, 47.603935 ], [ -122.313571, 47.603931 ], [ -122.314638, 47.603942 ], [ -122.315222, 47.604556 ], [ -122.314832, 47.604965 ], [ -122.313561, 47.604955 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14369", "project_id": 14, "task_id": 369, "numnodechanges": 8, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312202, 47.602482 ], [ -122.311419, 47.602466 ], [ -122.310989, 47.602162 ], [ -122.312234, 47.602182 ], [ -122.312231, 47.602395 ], [ -122.312202, 47.602482 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14156", "project_id": 14, "task_id": 156, "numnodechanges": 20, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316242, 47.599159 ], [ -122.31625, 47.597888 ], [ -122.316621, 47.597745 ], [ -122.316785, 47.597921 ], [ -122.316783, 47.59845 ], [ -122.316711, 47.598743 ], [ -122.316501, 47.599066 ], [ -122.316401, 47.59917 ], [ -122.316242, 47.599159 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14421", "project_id": 14, "task_id": 421, "numnodechanges": 8, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321503, 47.598907 ], [ -122.321924, 47.59865 ], [ -122.322133, 47.598929 ], [ -122.322207, 47.599105 ], [ -122.322196, 47.600077 ], [ -122.321497, 47.599861 ], [ -122.321503, 47.598907 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1412", "project_id": 14, "task_id": 12, "numnodechanges": 32, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318992, 47.598775 ], [ -122.31881, 47.598757 ], [ -122.318814, 47.597543 ], [ -122.319138, 47.597794 ], [ -122.319307, 47.59822 ], [ -122.319306, 47.598714 ], [ -122.319146, 47.598757 ], [ -122.318992, 47.598775 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14307", "project_id": 14, "task_id": 307, "numnodechanges": 390, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315306, 47.60173 ], [ -122.315357, 47.60218 ], [ -122.315305, 47.602222 ], [ -122.31469, 47.602219 ], [ -122.314657, 47.60217 ], [ -122.314805, 47.601717 ], [ -122.315306, 47.60173 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14292", "project_id": 14, "task_id": 292, "numnodechanges": 18, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313265, 47.601357 ], [ -122.313673, 47.601155 ], [ -122.313737, 47.601192 ], [ -122.313734, 47.602143 ], [ -122.313531, 47.60233 ], [ -122.313263, 47.601977 ], [ -122.313265, 47.601357 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1419", "project_id": 14, "task_id": 19, "numnodechanges": 172, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322779, 47.597937 ], [ -122.322781, 47.597939 ], [ -122.322779, 47.598608 ], [ -122.32195, 47.598598 ], [ -122.321952, 47.597932 ], [ -122.322779, 47.597937 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14397", "project_id": 14, "task_id": 397, "numnodechanges": 66, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31596, 47.606692 ], [ -122.314829, 47.606699 ], [ -122.314826, 47.606488 ], [ -122.314838, 47.606382 ], [ -122.315774, 47.606374 ], [ -122.31596, 47.606692 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1414", "project_id": 14, "task_id": 14, "numnodechanges": 12, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318394, 47.598841 ], [ -122.318401, 47.597155 ], [ -122.318432, 47.597102 ], [ -122.318438, 47.597097 ], [ -122.318814, 47.597543 ], [ -122.31881, 47.598757 ], [ -122.318438, 47.598875 ], [ -122.318394, 47.598841 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14433", "project_id": 14, "task_id": 433, "numnodechanges": 12, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316519, 47.60572 ], [ -122.315891, 47.605717 ], [ -122.315889, 47.605712 ], [ -122.315894, 47.604713 ], [ -122.316054, 47.604775 ], [ -122.316542, 47.605389 ], [ -122.316541, 47.60565 ], [ -122.316519, 47.60572 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14347", "project_id": 14, "task_id": 347, "numnodechanges": 347, "numwaychanges": 20 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32094, 47.606639 ], [ -122.320323, 47.606633 ], [ -122.320436, 47.606314 ], [ -122.321092, 47.606357 ], [ -122.32094, 47.606639 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14239", "project_id": 14, "task_id": 239, "numnodechanges": 76, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315952, 47.603061 ], [ -122.315472, 47.603174 ], [ -122.315299, 47.60305 ], [ -122.315305, 47.602222 ], [ -122.315357, 47.60218 ], [ -122.315886, 47.602182 ], [ -122.315958, 47.602212 ], [ -122.315952, 47.603061 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1477", "project_id": 14, "task_id": 77, "numnodechanges": 132, "numwaychanges": 19 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327618, 47.602835 ], [ -122.327853, 47.602931 ], [ -122.327902, 47.603261 ], [ -122.32776, 47.604236 ], [ -122.326569, 47.603794 ], [ -122.327618, 47.602835 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14133", "project_id": 14, "task_id": 133, "numnodechanges": 325, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311416, 47.605262 ], [ -122.312193, 47.605263 ], [ -122.312211, 47.605275 ], [ -122.312203, 47.606785 ], [ -122.31091, 47.606774 ], [ -122.310917, 47.605341 ], [ -122.311416, 47.605262 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14339", "project_id": 14, "task_id": 339, "numnodechanges": 57, "numwaychanges": 1 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316389, 47.601202 ], [ -122.316948, 47.601345 ], [ -122.316885, 47.601488 ], [ -122.316532, 47.601458 ], [ -122.316389, 47.601202 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1489", "project_id": 14, "task_id": 89, "numnodechanges": 89, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308978, 47.602678 ], [ -122.309305, 47.602161 ], [ -122.309348, 47.602158 ], [ -122.309609, 47.602347 ], [ -122.309624, 47.602389 ], [ -122.309625, 47.603042 ], [ -122.309574, 47.60311 ], [ -122.309267, 47.603106 ], [ -122.309226, 47.603103 ], [ -122.308978, 47.602678 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14171", "project_id": 14, "task_id": 171, "numnodechanges": 9, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324799, 47.608114 ], [ -122.324231, 47.608012 ], [ -122.323999, 47.607452 ], [ -122.324014, 47.607376 ], [ -122.324186, 47.60723 ], [ -122.32451, 47.607201 ], [ -122.324886, 47.608104 ], [ -122.324799, 47.608114 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14436", "project_id": 14, "task_id": 436, "numnodechanges": 366, "numwaychanges": 27 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320422, 47.602204 ], [ -122.321151, 47.602199 ], [ -122.321459, 47.602437 ], [ -122.321458, 47.602777 ], [ -122.320419, 47.602788 ], [ -122.320422, 47.602204 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14321", "project_id": 14, "task_id": 321, "numnodechanges": 10, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323333, 47.606052 ], [ -122.322904, 47.605795 ], [ -122.323356, 47.605382 ], [ -122.323777, 47.605482 ], [ -122.32366, 47.605752 ], [ -122.323333, 47.606052 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14336", "project_id": 14, "task_id": 336, "numnodechanges": 43, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316885, 47.601488 ], [ -122.316882, 47.601604 ], [ -122.316581, 47.601584 ], [ -122.316532, 47.601458 ], [ -122.316885, 47.601488 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14312", "project_id": 14, "task_id": 312, "numnodechanges": 12, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316281, 47.60218 ], [ -122.316581, 47.60188 ], [ -122.317094, 47.601882 ], [ -122.317289, 47.602202 ], [ -122.317122, 47.602388 ], [ -122.31651, 47.602386 ], [ -122.316281, 47.60218 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1413", "project_id": 14, "task_id": 13, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316541, 47.596623 ], [ -122.318592, 47.596653 ], [ -122.318438, 47.597097 ], [ -122.318432, 47.597102 ], [ -122.316621, 47.597081 ], [ -122.316532, 47.596949 ], [ -122.316541, 47.596623 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1447", "project_id": 14, "task_id": 47, "numnodechanges": 279, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308279, 47.606373 ], [ -122.307546, 47.606368 ], [ -122.307276, 47.606027 ], [ -122.306933, 47.605265 ], [ -122.30709, 47.605262 ], [ -122.308201, 47.605269 ], [ -122.308298, 47.605273 ], [ -122.308296, 47.606215 ], [ -122.308291, 47.606288 ], [ -122.308279, 47.606373 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1431", "project_id": 14, "task_id": 31, "numnodechanges": 24, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326707, 47.601873 ], [ -122.326708, 47.601318 ], [ -122.32744, 47.601283 ], [ -122.327646, 47.60174 ], [ -122.327268, 47.602312 ], [ -122.32685, 47.602095 ], [ -122.326707, 47.601873 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1454", "project_id": 14, "task_id": 54, "numnodechanges": 36, "numwaychanges": 13 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308329, 47.603105 ], [ -122.308656, 47.603103 ], [ -122.308947, 47.603521 ], [ -122.308776, 47.603767 ], [ -122.308324, 47.603813 ], [ -122.308329, 47.603105 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14277", "project_id": 14, "task_id": 277, "numnodechanges": 58, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312031, 47.596961 ], [ -122.312191, 47.596903 ], [ -122.312211, 47.596932 ], [ -122.31221, 47.597378 ], [ -122.311977, 47.597772 ], [ -122.311746, 47.597728 ], [ -122.311625, 47.597493 ], [ -122.312031, 47.596961 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14375", "project_id": 14, "task_id": 375, "numnodechanges": 103, "numwaychanges": 12 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315304, 47.600865 ], [ -122.315306, 47.60173 ], [ -122.314805, 47.601717 ], [ -122.314806, 47.601605 ], [ -122.315243, 47.600837 ], [ -122.315304, 47.600865 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14124", "project_id": 14, "task_id": 124, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31217, 47.607426 ], [ -122.312167, 47.608628 ], [ -122.311907, 47.608644 ], [ -122.311839, 47.60861 ], [ -122.311842, 47.607705 ], [ -122.31217, 47.607426 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14183", "project_id": 14, "task_id": 183, "numnodechanges": 57, "numwaychanges": 14 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313709, 47.598518 ], [ -122.313133, 47.598964 ], [ -122.313076, 47.59898 ], [ -122.312981, 47.598954 ], [ -122.313035, 47.598665 ], [ -122.313424, 47.598383 ], [ -122.313709, 47.598518 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1482", "project_id": 14, "task_id": 82, "numnodechanges": 80, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32315, 47.608848 ], [ -122.322387, 47.609542 ], [ -122.32237, 47.609549 ], [ -122.322056, 47.609179 ], [ -122.322949, 47.608376 ], [ -122.32315, 47.608848 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14205", "project_id": 14, "task_id": 205, "numnodechanges": 79, "numwaychanges": 8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309626, 47.59987 ], [ -122.309572, 47.599808 ], [ -122.309464, 47.599542 ], [ -122.309415, 47.599367 ], [ -122.309413, 47.599117 ], [ -122.309478, 47.59889 ], [ -122.30987, 47.598088 ], [ -122.309919, 47.598116 ], [ -122.309948, 47.599556 ], [ -122.309705, 47.599827 ], [ -122.309626, 47.59987 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14270", "project_id": 14, "task_id": 270, "numnodechanges": 18, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321449, 47.607923 ], [ -122.320135, 47.607998 ], [ -122.320676, 47.607517 ], [ -122.321226, 47.607506 ], [ -122.321437, 47.607796 ], [ -122.321449, 47.607923 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14245", "project_id": 14, "task_id": 245, "numnodechanges": 4, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324069, 47.5992 ], [ -122.324096, 47.598775 ], [ -122.324722, 47.598779 ], [ -122.32472, 47.599439 ], [ -122.324584, 47.599608 ], [ -122.324197, 47.599606 ], [ -122.324174, 47.599569 ], [ -122.324086, 47.599389 ], [ -122.324069, 47.5992 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14423", "project_id": 14, "task_id": 423, "numnodechanges": 0, "numwaychanges": 0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321367, 47.600759 ], [ -122.321357, 47.600795 ], [ -122.320891, 47.600802 ], [ -122.320794, 47.600009 ], [ -122.321167, 47.599969 ], [ -122.321367, 47.600759 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14382", "project_id": 14, "task_id": 382, "numnodechanges": 0, "numwaychanges": 1 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324124, 47.605965 ], [ -122.324276, 47.606327 ], [ -122.324152, 47.606388 ], [ -122.323828, 47.606066 ], [ -122.32403, 47.605882 ], [ -122.324124, 47.605965 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1425", "project_id": 14, "task_id": 25, "numnodechanges": 13, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323689, 47.603663 ], [ -122.325104, 47.602526 ], [ -122.325423, 47.60274 ], [ -122.324341, 47.604064 ], [ -122.323689, 47.60367 ], [ -122.323689, 47.603663 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14166", "project_id": 14, "task_id": 166, "numnodechanges": 12, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323315, 47.604594 ], [ -122.32344, 47.603899 ], [ -122.323689, 47.60367 ], [ -122.324341, 47.604064 ], [ -122.324492, 47.604251 ], [ -122.32393, 47.604767 ], [ -122.32361, 47.604776 ], [ -122.323315, 47.604594 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14283", "project_id": 14, "task_id": 283, "numnodechanges": 211, "numwaychanges": 24 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315777, 47.607775 ], [ -122.315775, 47.608362 ], [ -122.314818, 47.608363 ], [ -122.31482, 47.607762 ], [ -122.315777, 47.607775 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1499", "project_id": 14, "task_id": 99, "numnodechanges": 68, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313568, 47.59756 ], [ -122.31346, 47.597205 ], [ -122.313487, 47.597167 ], [ -122.314377, 47.59703 ], [ -122.314378, 47.597964 ], [ -122.313745, 47.597855 ], [ -122.313732, 47.597844 ], [ -122.313568, 47.59756 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14385", "project_id": 14, "task_id": 385, "numnodechanges": 462, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324448, 47.606327 ], [ -122.324736, 47.606998 ], [ -122.32451, 47.607201 ], [ -122.324186, 47.60723 ], [ -122.323926, 47.60659 ], [ -122.324152, 47.606388 ], [ -122.324276, 47.606327 ], [ -122.324448, 47.606327 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14135", "project_id": 14, "task_id": 135, "numnodechanges": 14, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310614, 47.607094 ], [ -122.311216, 47.607709 ], [ -122.311214, 47.608604 ], [ -122.311185, 47.608621 ], [ -122.310555, 47.608625 ], [ -122.310559, 47.607112 ], [ -122.310614, 47.607094 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14105", "project_id": 14, "task_id": 105, "numnodechanges": 34, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313907, 47.59925 ], [ -122.313908, 47.59961 ], [ -122.313832, 47.599653 ], [ -122.313552, 47.599605 ], [ -122.313076, 47.59898 ], [ -122.313133, 47.598964 ], [ -122.313658, 47.598993 ], [ -122.313907, 47.59925 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1479", "project_id": 14, "task_id": 79, "numnodechanges": 324, "numwaychanges": 20 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32375, 47.607679 ], [ -122.323973, 47.608213 ], [ -122.3238, 47.608395 ], [ -122.323551, 47.6078 ], [ -122.32375, 47.607679 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14152", "project_id": 14, "task_id": 152, "numnodechanges": 389, "numwaychanges": 22 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316501, 47.599066 ], [ -122.317387, 47.599067 ], [ -122.317391, 47.599624 ], [ -122.317059, 47.599616 ], [ -122.316701, 47.599468 ], [ -122.316472, 47.599261 ], [ -122.316401, 47.59917 ], [ -122.316501, 47.599066 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14193", "project_id": 14, "task_id": 193, "numnodechanges": 102, "numwaychanges": 16 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311216, 47.598859 ], [ -122.311962, 47.598859 ], [ -122.311723, 47.599068 ], [ -122.311394, 47.599068 ], [ -122.311216, 47.598859 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14287", "project_id": 14, "task_id": 287, "numnodechanges": 158, "numwaychanges": 21 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311533, 47.603905 ], [ -122.312076, 47.603747 ], [ -122.312199, 47.603935 ], [ -122.312193, 47.605263 ], [ -122.311416, 47.605262 ], [ -122.311421, 47.603947 ], [ -122.311533, 47.603905 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14243", "project_id": 14, "task_id": 243, "numnodechanges": 4, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324197, 47.599606 ], [ -122.324162, 47.599662 ], [ -122.323195, 47.599656 ], [ -122.32331, 47.599563 ], [ -122.324174, 47.599569 ], [ -122.324197, 47.599606 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14401", "project_id": 14, "task_id": 401, "numnodechanges": 18, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312904, 47.602681 ], [ -122.313154, 47.603098 ], [ -122.313123, 47.6031 ], [ -122.312609, 47.603095 ], [ -122.312874, 47.60268 ], [ -122.312904, 47.602681 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14368", "project_id": 14, "task_id": 368, "numnodechanges": 47, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312867, 47.603519 ], [ -122.312621, 47.603928 ], [ -122.312519, 47.603934 ], [ -122.312199, 47.603935 ], [ -122.312076, 47.603747 ], [ -122.312076, 47.603287 ], [ -122.312204, 47.603095 ], [ -122.312533, 47.603099 ], [ -122.312867, 47.603519 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14428", "project_id": 14, "task_id": 428, "numnodechanges": 4, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317111, 47.60539 ], [ -122.317113, 47.604781 ], [ -122.317779, 47.604781 ], [ -122.317782, 47.604783 ], [ -122.317779, 47.605708 ], [ -122.317299, 47.605706 ], [ -122.317254, 47.605647 ], [ -122.317111, 47.60539 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14282", "project_id": 14, "task_id": 282, "numnodechanges": 69, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316127, 47.607322 ], [ -122.316129, 47.606995 ], [ -122.316131, 47.606986 ], [ -122.317558, 47.606994 ], [ -122.317752, 47.607133 ], [ -122.317591, 47.60736 ], [ -122.31614, 47.607369 ], [ -122.316127, 47.607322 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14154", "project_id": 14, "task_id": 154, "numnodechanges": 21, "numwaychanges": 9 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316711, 47.598743 ], [ -122.317625, 47.598744 ], [ -122.317654, 47.598771 ], [ -122.317387, 47.599067 ], [ -122.316501, 47.599066 ], [ -122.316711, 47.598743 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "143", "project_id": 14, "task_id": 3, "numnodechanges": 165, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326697, 47.60046 ], [ -122.326691, 47.601304 ], [ -122.32603, 47.601294 ], [ -122.325497, 47.60087 ], [ -122.326031, 47.600458 ], [ -122.326694, 47.600458 ], [ -122.326697, 47.60046 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1439", "project_id": 14, "task_id": 39, "numnodechanges": 390, "numwaychanges": 27 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313432, 47.597207 ], [ -122.312695, 47.597843 ], [ -122.31221, 47.597378 ], [ -122.312211, 47.596932 ], [ -122.313432, 47.597207 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1484", "project_id": 14, "task_id": 84, "numnodechanges": 298, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322056, 47.609179 ], [ -122.32186, 47.609008 ], [ -122.321823, 47.608851 ], [ -122.322935, 47.607825 ], [ -122.323047, 47.608104 ], [ -122.322949, 47.608376 ], [ -122.322056, 47.609179 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14383", "project_id": 14, "task_id": 383, "numnodechanges": 82, "numwaychanges": 5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323828, 47.606066 ], [ -122.323788, 47.606061 ], [ -122.32366, 47.605752 ], [ -122.323777, 47.605482 ], [ -122.323852, 47.605455 ], [ -122.32403, 47.605882 ], [ -122.323828, 47.606066 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1443", "project_id": 14, "task_id": 43, "numnodechanges": 0, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.307941, 47.603921 ], [ -122.307985, 47.603925 ], [ -122.307684, 47.60432 ], [ -122.307655, 47.60432 ], [ -122.307333, 47.603923 ], [ -122.307388, 47.603918 ], [ -122.307941, 47.603921 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14398", "project_id": 14, "task_id": 398, "numnodechanges": 6, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314838, 47.606382 ], [ -122.314826, 47.606488 ], [ -122.313481, 47.606487 ], [ -122.31351, 47.606302 ], [ -122.314825, 47.606298 ], [ -122.314838, 47.606382 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1470", "project_id": 14, "task_id": 70, "numnodechanges": 37, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32195, 47.598598 ], [ -122.322779, 47.598608 ], [ -122.322866, 47.598729 ], [ -122.322771, 47.598926 ], [ -122.322133, 47.598929 ], [ -122.321924, 47.59865 ], [ -122.32195, 47.598598 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14115", "project_id": 14, "task_id": 115, "numnodechanges": 118, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311563, 47.609209 ], [ -122.311902, 47.608721 ], [ -122.3119, 47.609515 ], [ -122.311695, 47.609441 ], [ -122.311563, 47.609209 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14127", "project_id": 14, "task_id": 127, "numnodechanges": 23, "numwaychanges": 10 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312462, 47.608631 ], [ -122.312502, 47.608975 ], [ -122.3125, 47.609718 ], [ -122.3125, 47.609731 ], [ -122.3119, 47.609515 ], [ -122.311902, 47.608721 ], [ -122.311907, 47.608644 ], [ -122.312167, 47.608628 ], [ -122.312462, 47.608631 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14429", "project_id": 14, "task_id": 429, "numnodechanges": 56, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317299, 47.605706 ], [ -122.317779, 47.605708 ], [ -122.317782, 47.60571 ], [ -122.31778, 47.607124 ], [ -122.317752, 47.607133 ], [ -122.317558, 47.606994 ], [ -122.31727, 47.606691 ], [ -122.317109, 47.606377 ], [ -122.31711, 47.606035 ], [ -122.317236, 47.605792 ], [ -122.317299, 47.605706 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14130", "project_id": 14, "task_id": 130, "numnodechanges": 29, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312895, 47.604339 ], [ -122.313352, 47.60517 ], [ -122.313242, 47.605291 ], [ -122.312298, 47.605274 ], [ -122.312866, 47.604342 ], [ -122.312895, 47.604339 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14175", "project_id": 14, "task_id": 175, "numnodechanges": 101, "numwaychanges": 17 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31958, 47.609034 ], [ -122.321832, 47.609022 ], [ -122.321222, 47.609483 ], [ -122.319118, 47.609491 ], [ -122.31958, 47.609034 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14137", "project_id": 14, "task_id": 137, "numnodechanges": 6, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309941, 47.607105 ], [ -122.309938, 47.60856 ], [ -122.3096, 47.608373 ], [ -122.309155, 47.608007 ], [ -122.3097, 47.607193 ], [ -122.309853, 47.607103 ], [ -122.309931, 47.607101 ], [ -122.309941, 47.607105 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14331", "project_id": 14, "task_id": 331, "numnodechanges": 159, "numwaychanges": 17 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316131, 47.606986 ], [ -122.316129, 47.606995 ], [ -122.314773, 47.60698 ], [ -122.314829, 47.606699 ], [ -122.31596, 47.606692 ], [ -122.316131, 47.60685 ], [ -122.316131, 47.606986 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14206", "project_id": 14, "task_id": 206, "numnodechanges": 115, "numwaychanges": 23 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317798, 47.609396 ], [ -122.316397, 47.609391 ], [ -122.3164, 47.60898 ], [ -122.317732, 47.608976 ], [ -122.317994, 47.609263 ], [ -122.317798, 47.609396 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1468", "project_id": 14, "task_id": 68, "numnodechanges": 169, "numwaychanges": 11 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322771, 47.598926 ], [ -122.322731, 47.599105 ], [ -122.322207, 47.599105 ], [ -122.322133, 47.598929 ], [ -122.322771, 47.598926 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "141", "project_id": 14, "task_id": 1, "numnodechanges": 52, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327184, 47.605077 ], [ -122.327344, 47.605455 ], [ -122.327086, 47.606027 ], [ -122.326987, 47.606153 ], [ -122.326558, 47.605139 ], [ -122.327184, 47.605077 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14299", "project_id": 14, "task_id": 299, "numnodechanges": 2, "numwaychanges": 3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317453, 47.60835 ], [ -122.317527, 47.60859 ], [ -122.3166, 47.608592 ], [ -122.316655, 47.608353 ], [ -122.317453, 47.60835 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14412", "project_id": 14, "task_id": 412, "numnodechanges": 10, "numwaychanges": 6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316959, 47.600228 ], [ -122.317054, 47.600076 ], [ -122.318145, 47.600411 ], [ -122.318146, 47.600498 ], [ -122.316959, 47.600228 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14143", "project_id": 14, "task_id": 143, "numnodechanges": 93, "numwaychanges": 18 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.30935, 47.601264 ], [ -122.308314, 47.601261 ], [ -122.307765, 47.600418 ], [ -122.309558, 47.600431 ], [ -122.30959, 47.600533 ], [ -122.309588, 47.601042 ], [ -122.30935, 47.601264 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1460", "project_id": 14, "task_id": 60, "numnodechanges": 8, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309615, 47.604075 ], [ -122.3091, 47.60414 ], [ -122.308807, 47.604136 ], [ -122.308314, 47.604061 ], [ -122.308278, 47.603932 ], [ -122.308324, 47.603813 ], [ -122.308776, 47.603767 ], [ -122.30913, 47.603769 ], [ -122.309576, 47.603824 ], [ -122.309639, 47.603988 ], [ -122.309615, 47.604075 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "1449", "project_id": 14, "task_id": 49, "numnodechanges": 160, "numwaychanges": 25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314813, 47.609767 ], [ -122.314426, 47.610216 ], [ -122.313744, 47.610076 ], [ -122.313746, 47.608628 ], [ -122.314686, 47.608636 ], [ -122.314815, 47.608947 ], [ -122.314813, 47.609767 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14160", "project_id": 14, "task_id": 160, "numnodechanges": 4, "numwaychanges": 4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323195, 47.599656 ], [ -122.324162, 47.599662 ], [ -122.324098, 47.599799 ], [ -122.323091, 47.59978 ], [ -122.323191, 47.599658 ], [ -122.323195, 47.599656 ] ] ] ] } }, +{ "type": "Feature", "properties": { "pk": "14290", "project_id": 14, "task_id": 290, "numnodechanges": 0, "numwaychanges": 2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310749, 47.602516 ], [ -122.309624, 47.602389 ], [ -122.309609, 47.602347 ], [ -122.309872, 47.602093 ], [ -122.309907, 47.602076 ], [ -122.310921, 47.602091 ], [ -122.310925, 47.602129 ], [ -122.310749, 47.602516 ] ] ] ] } } +] +} diff --git a/tests/xnqm/outputs/p13_scores.geojson b/tests/xnqm/outputs/p13_scores.geojson new file mode 100644 index 0000000..f2fa16c --- /dev/null +++ b/tests/xnqm/outputs/p13_scores.geojson @@ -0,0 +1,270 @@ +{ +"type": "FeatureCollection", +"crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:OGC:1.3:CRS84" } }, +"features": [ +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.338691909891793, 47.605130746783828 ], [ -122.339476555025513, 47.604407419524023 ], [ -122.3395227, 47.6051627 ], [ -122.339200324062148, 47.605594792327636 ], [ -122.338691909891793, 47.605130746783828 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.339200324062148, 47.605594792327636 ], [ -122.338645992733518, 47.60633778299767 ], [ -122.338601725657384, 47.606320733733284 ], [ -122.338219849131619, 47.605394032917467 ], [ -122.338541868754064, 47.605104398655044 ], [ -122.338691909891793, 47.605130746783828 ], [ -122.339200324062148, 47.605594792327636 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.46666666666666667 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.335781241946449, 47.598741682777941 ], [ -122.335587454401477, 47.596844367512148 ], [ -122.335809680368399, 47.596642523472404 ], [ -122.3358652, 47.5966583 ], [ -122.337175277551538, 47.598669554877418 ], [ -122.335781241946449, 47.598741682777941 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.027777777777777776 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.338487915156307, 47.601952763419483 ], [ -122.337141819627988, 47.601770538529905 ], [ -122.337068734650487, 47.601687070214439 ], [ -122.337007427182385, 47.600604367143546 ], [ -122.337068108268554, 47.600420189416695 ], [ -122.337330755934161, 47.600047640249436 ], [ -122.337811823030833, 47.599646791071095 ], [ -122.338775526263873, 47.601126285796845 ], [ -122.338487915156307, 47.601952763419483 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.33849383095118, 47.602096160155291 ], [ -122.338487915156307, 47.601952763419483 ], [ -122.338775526263873, 47.601126285796845 ], [ -122.339327900000015, 47.6019743 ], [ -122.33933584589883, 47.602104354947905 ], [ -122.33849383095118, 47.602096160155291 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.083333333333333329 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.338319823717072, 47.602804043601289 ], [ -122.338310881144722, 47.602804064394945 ], [ -122.337473020458432, 47.602595347453921 ], [ -122.337141819627988, 47.601770538529905 ], [ -122.338487915156307, 47.601952763419483 ], [ -122.33849383095118, 47.602096160155291 ], [ -122.338489233052371, 47.602327691052139 ], [ -122.338365901850452, 47.602729409533062 ], [ -122.338319823717072, 47.602804043601289 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.339090720537172, 47.603797663152363 ], [ -122.338473543011645, 47.603176038714572 ], [ -122.338319823717072, 47.602804043601289 ], [ -122.338365901850452, 47.602729409533062 ], [ -122.339374496059406, 47.602736963633212 ], [ -122.33944353226434, 47.603866917615782 ], [ -122.339090720537172, 47.603797663152363 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.338489233052371, 47.602327691052139 ], [ -122.33849383095118, 47.602096160155291 ], [ -122.33933584589883, 47.602104354947905 ], [ -122.339350147407174, 47.602338435693063 ], [ -122.338489233052371, 47.602327691052139 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.338365901850452, 47.602729409533062 ], [ -122.338489233052371, 47.602327691052139 ], [ -122.339350147407174, 47.602338435693063 ], [ -122.339374496059406, 47.602736963633212 ], [ -122.338365901850452, 47.602729409533062 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.339090720537172, 47.603797663152363 ], [ -122.338403693062219, 47.604337386124435 ], [ -122.338057271739132, 47.603644543478261 ], [ -122.338473543011645, 47.603176038714572 ], [ -122.339090720537172, 47.603797663152363 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.339090720537172, 47.603797663152363 ], [ -122.33944353226434, 47.603866917615782 ], [ -122.339476555025513, 47.604407419524023 ], [ -122.338691909891793, 47.605130746783828 ], [ -122.338541868754064, 47.605104398655044 ], [ -122.338286225346593, 47.604456129386051 ], [ -122.338403693062219, 47.604337386124435 ], [ -122.339090720537172, 47.603797663152363 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.13333333333333333 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.33752661502669, 47.606788190347231 ], [ -122.337980136207051, 47.606376329392411 ], [ -122.338601725657384, 47.606320733733284 ], [ -122.338645992733518, 47.60633778299767 ], [ -122.337808562834354, 47.607460221095195 ], [ -122.33752661502669, 47.606788190347231 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.338219849131619, 47.605394032917467 ], [ -122.33789400467569, 47.605431925831567 ], [ -122.337576782524522, 47.604677734469448 ], [ -122.33786975855692, 47.604405884317039 ], [ -122.338286225346593, 47.604456129386051 ], [ -122.338541868754064, 47.605104398655044 ], [ -122.338219849131619, 47.605394032917467 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.338286225346593, 47.604456129386051 ], [ -122.33786975855692, 47.604405884317039 ], [ -122.337667604863015, 47.603919602449615 ], [ -122.338057271739132, 47.603644543478261 ], [ -122.338403693062219, 47.604337386124435 ], [ -122.338286225346593, 47.604456129386051 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.338473543011645, 47.603176038714572 ], [ -122.338057271739132, 47.603644543478261 ], [ -122.337667604863015, 47.603919602449615 ], [ -122.337292844806825, 47.603678063581341 ], [ -122.338310881144722, 47.602804064394945 ], [ -122.338319823717072, 47.602804043601289 ], [ -122.338473543011645, 47.603176038714572 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.336422952560198, 47.60725609378639 ], [ -122.337105740831873, 47.606629004404311 ], [ -122.33752661502669, 47.606788190347231 ], [ -122.337808562834354, 47.607460221095195 ], [ -122.336972864672859, 47.608580338080991 ], [ -122.336422952560198, 47.60725609378639 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.338601725657384, 47.606320733733284 ], [ -122.337980136207051, 47.606376329392411 ], [ -122.337668868322197, 47.605630498345455 ], [ -122.33789400467569, 47.605431925831567 ], [ -122.338219849131619, 47.605394032917467 ], [ -122.338601725657384, 47.606320733733284 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.337668868322197, 47.605630498345455 ], [ -122.337338279090318, 47.605654410517353 ], [ -122.337028012723692, 47.604916745524633 ], [ -122.337250798687393, 47.604722739043687 ], [ -122.337576782524522, 47.604677734469448 ], [ -122.33789400467569, 47.605431925831567 ], [ -122.337668868322197, 47.605630498345455 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.33786975855692, 47.604405884317039 ], [ -122.337576782524522, 47.604677734469448 ], [ -122.337250798687393, 47.604722739043687 ], [ -122.336939808685528, 47.603964530248909 ], [ -122.337261843620325, 47.603671850442772 ], [ -122.337292844806825, 47.603678063581341 ], [ -122.337667604863015, 47.603919602449615 ], [ -122.33786975855692, 47.604405884317039 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.337007427182385, 47.600604367143546 ], [ -122.335879357695831, 47.601364578858636 ], [ -122.3352005216517, 47.601240452514233 ], [ -122.33496672462816, 47.601006905303478 ], [ -122.334967733655034, 47.600498947253534 ], [ -122.337068108268554, 47.600420189416695 ], [ -122.337007427182385, 47.600604367143546 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.337980136207051, 47.606376329392411 ], [ -122.33752661502669, 47.606788190347231 ], [ -122.337105740831873, 47.606629004404311 ], [ -122.336873884407808, 47.606075150278038 ], [ -122.337338279090318, 47.605654410517353 ], [ -122.337668868322197, 47.605630498345455 ], [ -122.337980136207051, 47.606376329392411 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.337473020458432, 47.602595347453921 ], [ -122.33700168139714, 47.603049277555094 ], [ -122.336591288236164, 47.602976626661743 ], [ -122.336324567550506, 47.602301854258066 ], [ -122.337068734650487, 47.601687070214439 ], [ -122.337141819627988, 47.601770538529905 ], [ -122.337473020458432, 47.602595347453921 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.53333333333333333 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.337473020458432, 47.602595347453921 ], [ -122.338310881144722, 47.602804064394945 ], [ -122.337292844806825, 47.603678063581341 ], [ -122.337261843620325, 47.603671850442772 ], [ -122.33700168139714, 47.603049277555094 ], [ -122.337473020458432, 47.602595347453921 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.337338279090318, 47.605654410517353 ], [ -122.336873884407808, 47.606075150278038 ], [ -122.33645546129631, 47.60591276437971 ], [ -122.336224448728714, 47.605363669472382 ], [ -122.33669829639696, 47.604933888310001 ], [ -122.337028012723692, 47.604916745524633 ], [ -122.337338279090318, 47.605654410517353 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.336939808685528, 47.603964530248909 ], [ -122.33661504201406, 47.604014045440913 ], [ -122.336295494188022, 47.603254238529573 ], [ -122.336591288236164, 47.602976626661743 ], [ -122.33700168139714, 47.603049277555094 ], [ -122.337261843620325, 47.603671850442772 ], [ -122.336939808685528, 47.603964530248909 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.33531657766018, 47.607708124517941 ], [ -122.335993203675116, 47.607088528140608 ], [ -122.336422952560198, 47.60725609378639 ], [ -122.336972864672859, 47.608580338080991 ], [ -122.3369335, 47.6086331 ], [ -122.335882812290109, 47.6090716665488 ], [ -122.33531657766018, 47.607708124517941 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.336396821626764, 47.604212208922192 ], [ -122.33661504201406, 47.604014045440913 ], [ -122.336939808685528, 47.603964530248909 ], [ -122.337250798687393, 47.604722739043687 ], [ -122.337028012723692, 47.604916745524633 ], [ -122.33669829639696, 47.604933888310001 ], [ -122.336396821626764, 47.604212208922192 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.33669829639696, 47.604933888310001 ], [ -122.336224448728714, 47.605363669472382 ], [ -122.335802749999687, 47.605199335990221 ], [ -122.335580734583502, 47.604666059451517 ], [ -122.336066300182694, 47.604225037937219 ], [ -122.336396821626764, 47.604212208922192 ], [ -122.33669829639696, 47.604933888310001 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.337105740831873, 47.606629004404311 ], [ -122.336422952560198, 47.60725609378639 ], [ -122.335993203675116, 47.607088528140608 ], [ -122.335767869510036, 47.606543767439476 ], [ -122.33645546129631, 47.60591276437971 ], [ -122.336873884407808, 47.606075150278038 ], [ -122.337105740831873, 47.606629004404311 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.33661504201406, 47.604014045440913 ], [ -122.336396821626764, 47.604212208922192 ], [ -122.336066300182694, 47.604225037937219 ], [ -122.335752647424471, 47.603499555062676 ], [ -122.335950672484771, 47.603317988658183 ], [ -122.336295494188022, 47.603254238529573 ], [ -122.33661504201406, 47.604014045440913 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.336295494188022, 47.603254238529573 ], [ -122.335950672484771, 47.603317988658183 ], [ -122.33557751710515, 47.602380911730357 ], [ -122.335915239371445, 47.602226351388353 ], [ -122.336324567550506, 47.602301854258066 ], [ -122.336591288236164, 47.602976626661743 ], [ -122.336295494188022, 47.603254238529573 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.336224448728714, 47.605363669472382 ], [ -122.33645546129631, 47.60591276437971 ], [ -122.335767869510036, 47.606543767439476 ], [ -122.335351824284018, 47.60637824406998 ], [ -122.335119645145525, 47.605826279539258 ], [ -122.335802749999687, 47.605199335990221 ], [ -122.336224448728714, 47.605363669472382 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.337007427182385, 47.600604367143546 ], [ -122.337068734650487, 47.601687070214439 ], [ -122.336324567550506, 47.602301854258066 ], [ -122.335915239371445, 47.602226351388353 ], [ -122.335879357695831, 47.601364578858636 ], [ -122.337007427182385, 47.600604367143546 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.335580734583502, 47.604666059451517 ], [ -122.335157605575631, 47.604487759346647 ], [ -122.334937804162564, 47.603944148935675 ], [ -122.335400750062192, 47.603524747142195 ], [ -122.335752647424471, 47.603499555062676 ], [ -122.336066300182694, 47.604225037937219 ], [ -122.335580734583502, 47.604666059451517 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.331739490808445, 47.609314754852974 ], [ -122.33266651907249, 47.608478739181479 ], [ -122.333081296496701, 47.608645350788713 ], [ -122.333650416377338, 47.610003488784692 ], [ -122.3335996, 47.6100247 ], [ -122.331683960541369, 47.609956193581425 ], [ -122.331739490808445, 47.609314754852974 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.334212330066649, 47.608183648219381 ], [ -122.334895012599446, 47.607552306810085 ], [ -122.33531657766018, 47.607708124517941 ], [ -122.335882812290109, 47.6090716665488 ], [ -122.334772200847539, 47.60953524580539 ], [ -122.334212330066649, 47.608183648219381 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.8 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.33557751710515, 47.602380911730357 ], [ -122.335197030547945, 47.602382542175292 ], [ -122.3352005216517, 47.601240452514233 ], [ -122.335879357695831, 47.601364578858636 ], [ -122.335915239371445, 47.602226351388353 ], [ -122.33557751710515, 47.602380911730357 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.337330755934161, 47.600047640249436 ], [ -122.335784492009978, 47.599634783886799 ], [ -122.335780668757963, 47.598741842133158 ], [ -122.335781241946449, 47.598741682777941 ], [ -122.337175277551538, 47.598669554877418 ], [ -122.337811823030833, 47.599646791071095 ], [ -122.337330755934161, 47.600047640249436 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.334923424072187, 47.597363642437514 ], [ -122.334955603153702, 47.598777349160535 ], [ -122.334195567540462, 47.598764623294358 ], [ -122.334193931757014, 47.598764388424669 ], [ -122.33419809478049, 47.597386427650882 ], [ -122.334923424072187, 47.597363642437514 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.12727272727272726 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.335587454401477, 47.596844367512148 ], [ -122.334923424072187, 47.597363642437514 ], [ -122.33419809478049, 47.597386427650882 ], [ -122.333690906919244, 47.597366110564394 ], [ -122.333077205752886, 47.597048524441959 ], [ -122.332910463183879, 47.59693088165438 ], [ -122.332525763303025, 47.595787392608081 ], [ -122.33314080000001, 47.5958853 ], [ -122.3333448, 47.5959421 ], [ -122.335809680368399, 47.596642523472404 ], [ -122.335587454401477, 47.596844367512148 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.335119645145525, 47.605826279539258 ], [ -122.334694717580376, 47.605666039073128 ], [ -122.334463459780665, 47.60512488602275 ], [ -122.335157605575631, 47.604487759346647 ], [ -122.335580734583502, 47.604666059451517 ], [ -122.335802749999687, 47.605199335990221 ], [ -122.335119645145525, 47.605826279539258 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.335993203675116, 47.607088528140608 ], [ -122.33531657766018, 47.607708124517941 ], [ -122.334895012599446, 47.607552306810085 ], [ -122.334659039668722, 47.606998407498871 ], [ -122.335351824284018, 47.60637824406998 ], [ -122.335767869510036, 47.606543767439476 ], [ -122.335993203675116, 47.607088528140608 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.337068108268554, 47.600420189416695 ], [ -122.334967733655034, 47.600498947253534 ], [ -122.334957060796512, 47.600480854699804 ], [ -122.334954089206491, 47.599637339156509 ], [ -122.334962741207661, 47.599622548404135 ], [ -122.335784492009978, 47.599634783886799 ], [ -122.337330755934161, 47.600047640249436 ], [ -122.337068108268554, 47.600420189416695 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6071428571428571 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.335950672484771, 47.603317988658183 ], [ -122.335752647424471, 47.603499555062676 ], [ -122.335400750062192, 47.603524747142195 ], [ -122.335012975371583, 47.602551820605839 ], [ -122.335046640598648, 47.602463551073768 ], [ -122.335197030547945, 47.602382542175292 ], [ -122.33557751710515, 47.602380911730357 ], [ -122.335950672484771, 47.603317988658183 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.335784492009978, 47.599634783886799 ], [ -122.334962741207661, 47.599622548404135 ], [ -122.334961103607995, 47.598785442543878 ], [ -122.335780668757963, 47.598741842133158 ], [ -122.335784492009978, 47.599634783886799 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.334967733655034, 47.600498947253534 ], [ -122.33496672462816, 47.601006905303478 ], [ -122.334542818342413, 47.601317111216538 ], [ -122.334183894315188, 47.601313967232393 ], [ -122.33418310833369, 47.600472967044183 ], [ -122.334185643198751, 47.600472656948611 ], [ -122.334957060796512, 47.600480854699804 ], [ -122.334967733655034, 47.600498947253534 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.335780668757963, 47.598741842133158 ], [ -122.334961103607995, 47.598785442543878 ], [ -122.334955603153702, 47.598777349160535 ], [ -122.334923424072187, 47.597363642437514 ], [ -122.335587454401477, 47.596844367512148 ], [ -122.335781241946449, 47.598741682777941 ], [ -122.335780668757963, 47.598741842133158 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.334937804162564, 47.603944148935675 ], [ -122.334494922334912, 47.603773559062944 ], [ -122.334272160616791, 47.603223818768981 ], [ -122.335012975371583, 47.602551820605839 ], [ -122.335400750062192, 47.603524747142195 ], [ -122.334937804162564, 47.603944148935675 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.3352005216517, 47.601240452514233 ], [ -122.335197030547945, 47.602382542175292 ], [ -122.335046640598648, 47.602463551073768 ], [ -122.334542306718916, 47.602117674078059 ], [ -122.334542818342413, 47.601317111216538 ], [ -122.33496672462816, 47.601006905303478 ], [ -122.3352005216517, 47.601240452514233 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.334659039668722, 47.606998407498871 ], [ -122.334247395462896, 47.606839518034526 ], [ -122.334019376320526, 47.606297390389678 ], [ -122.334694717580376, 47.605666039073128 ], [ -122.335119645145525, 47.605826279539258 ], [ -122.335351824284018, 47.60637824406998 ], [ -122.334659039668722, 47.606998407498871 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.334463459780665, 47.60512488602275 ], [ -122.334049122506016, 47.604961555117562 ], [ -122.333817480267086, 47.604395284375585 ], [ -122.334494922334912, 47.603773559062944 ], [ -122.334937804162564, 47.603944148935675 ], [ -122.335157605575631, 47.604487759346647 ], [ -122.334463459780665, 47.60512488602275 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.334962741207661, 47.599622548404135 ], [ -122.334954089206491, 47.599637339156509 ], [ -122.334194637081481, 47.599636975347096 ], [ -122.334182684411601, 47.5996353712409 ], [ -122.334195567540462, 47.598764623294358 ], [ -122.334955603153702, 47.598777349160535 ], [ -122.334961103607995, 47.598785442543878 ], [ -122.334962741207661, 47.599622548404135 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.333081296496701, 47.608645350788713 ], [ -122.333783812005549, 47.608009741518785 ], [ -122.334212330066649, 47.608183648219381 ], [ -122.334772200847539, 47.60953524580539 ], [ -122.333650416377338, 47.610003488784692 ], [ -122.333081296496701, 47.608645350788713 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.335012975371583, 47.602551820605839 ], [ -122.334272160616791, 47.603223818768981 ], [ -122.333850877262989, 47.603049102702343 ], [ -122.333592589225134, 47.602447876256008 ], [ -122.333859281942722, 47.60221803204665 ], [ -122.334177650000015, 47.602149453814334 ], [ -122.334542306718916, 47.602117674078059 ], [ -122.335046640598648, 47.602463551073768 ], [ -122.335012975371583, 47.602551820605839 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.334019376320526, 47.606297390389678 ], [ -122.333581233784543, 47.606130706949017 ], [ -122.33335565945481, 47.605581134829343 ], [ -122.334049122506016, 47.604961555117562 ], [ -122.334463459780665, 47.60512488602275 ], [ -122.334694717580376, 47.605666039073128 ], [ -122.334019376320526, 47.606297390389678 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.334895012599446, 47.607552306810085 ], [ -122.334212330066649, 47.608183648219381 ], [ -122.333783812005549, 47.608009741518785 ], [ -122.333562825344671, 47.607472554078477 ], [ -122.334247395462896, 47.606839518034526 ], [ -122.334659039668722, 47.606998407498871 ], [ -122.334895012599446, 47.607552306810085 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.333817480267086, 47.604395284375585 ], [ -122.333385624512417, 47.604238897105986 ], [ -122.333150097526968, 47.603692209257652 ], [ -122.333850877262989, 47.603049102702343 ], [ -122.334272160616791, 47.603223818768981 ], [ -122.334494922334912, 47.603773559062944 ], [ -122.333817480267086, 47.604395284375585 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.334177650000015, 47.602149453814334 ], [ -122.334177650000015, 47.60131470351012 ], [ -122.334183894315188, 47.601313967232393 ], [ -122.334542818342413, 47.601317111216538 ], [ -122.334542306718916, 47.602117674078059 ], [ -122.334177650000015, 47.602149453814334 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5357142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.334182684411601, 47.5996353712409 ], [ -122.333522637313237, 47.599637741248422 ], [ -122.333511222717263, 47.59921296745442 ], [ -122.333523276851949, 47.598924181163639 ], [ -122.333686150803885, 47.598765676782307 ], [ -122.334193931757014, 47.598764388424669 ], [ -122.334195567540462, 47.598764623294358 ], [ -122.334182684411601, 47.5996353712409 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.334957060796512, 47.600480854699804 ], [ -122.334185643198751, 47.600472656948611 ], [ -122.334194637081481, 47.599636975347096 ], [ -122.334954089206491, 47.599637339156509 ], [ -122.334957060796512, 47.600480854699804 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5357142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.33418310833369, 47.600472967044183 ], [ -122.33349876710227, 47.600469377271395 ], [ -122.333239477523449, 47.600076211817971 ], [ -122.333522637313237, 47.599637741248422 ], [ -122.334182684411601, 47.5996353712409 ], [ -122.334194637081481, 47.599636975347096 ], [ -122.334185643198751, 47.600472656948611 ], [ -122.33418310833369, 47.600472967044183 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.334019376320526, 47.606297390389678 ], [ -122.334247395462896, 47.606839518034526 ], [ -122.333562825344671, 47.607472554078477 ], [ -122.333140483081678, 47.607302793302338 ], [ -122.332910949905937, 47.606757356219816 ], [ -122.333581233784543, 47.606130706949017 ], [ -122.334019376320526, 47.606297390389678 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.334183894315188, 47.601313967232393 ], [ -122.334177650000015, 47.60131470351012 ], [ -122.333865124567481, 47.601313112579184 ], [ -122.333497653778721, 47.601081221170951 ], [ -122.33349876710227, 47.600469377271395 ], [ -122.33418310833369, 47.600472967044183 ], [ -122.334183894315188, 47.601313967232393 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.334177650000015, 47.602149453814334 ], [ -122.333859281942722, 47.60221803204665 ], [ -122.333865124567481, 47.601313112579184 ], [ -122.334177650000015, 47.60131470351012 ], [ -122.334177650000015, 47.602149453814334 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327864629042722, 47.596024850046575 ], [ -122.327061694655768, 47.595957820360837 ], [ -122.327044781231521, 47.595177586603775 ], [ -122.328408601746077, 47.59519911194846 ], [ -122.327864629042722, 47.596024850046575 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.333865124567481, 47.601313112579184 ], [ -122.333859281942722, 47.60221803204665 ], [ -122.333592589225134, 47.602447876256008 ], [ -122.333229234031165, 47.602329608472374 ], [ -122.333234375781018, 47.601310013371197 ], [ -122.333497653778721, 47.601081221170951 ], [ -122.333865124567481, 47.601313112579184 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.334193931757014, 47.598764388424669 ], [ -122.333686150803885, 47.598765676782307 ], [ -122.333690906919244, 47.597366110564394 ], [ -122.33419809478049, 47.597386427650882 ], [ -122.334193931757014, 47.598764388424669 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.333523276851949, 47.598924181163639 ], [ -122.333071361686606, 47.598737946597353 ], [ -122.333077205752886, 47.597048524441959 ], [ -122.333690906919244, 47.597366110564394 ], [ -122.333686150803885, 47.598765676782307 ], [ -122.333523276851949, 47.598924181163639 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.53333333333333333 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.333239477523449, 47.600076211817971 ], [ -122.332514909522246, 47.600064627219432 ], [ -122.332564136413495, 47.599206282139413 ], [ -122.333511222717263, 47.59921296745442 ], [ -122.333522637313237, 47.599637741248422 ], [ -122.333239477523449, 47.600076211817971 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.33335565945481, 47.605581134829343 ], [ -122.332941007806582, 47.60541547147222 ], [ -122.332715055650624, 47.604863623919236 ], [ -122.333385624512417, 47.604238897105986 ], [ -122.333817480267086, 47.604395284375585 ], [ -122.334049122506016, 47.604961555117562 ], [ -122.33335565945481, 47.605581134829343 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.333523276851949, 47.598924181163639 ], [ -122.333511222717263, 47.59921296745442 ], [ -122.332564136413495, 47.599206282139413 ], [ -122.332530330676363, 47.598733789665253 ], [ -122.333071361686606, 47.598737946597353 ], [ -122.333523276851949, 47.598924181163639 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.333592589225134, 47.602447876256008 ], [ -122.333850877262989, 47.603049102702343 ], [ -122.333150097526968, 47.603692209257652 ], [ -122.332733327250622, 47.603527325635028 ], [ -122.332510528895284, 47.602980868837761 ], [ -122.333216992394071, 47.602332546427583 ], [ -122.333229234031165, 47.602329608472374 ], [ -122.333592589225134, 47.602447876256008 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.333562825344671, 47.607472554078477 ], [ -122.333783812005549, 47.608009741518785 ], [ -122.333081296496701, 47.608645350788713 ], [ -122.33266651907249, 47.608478739181479 ], [ -122.332438830967234, 47.607937992016858 ], [ -122.333140483081678, 47.607302793302338 ], [ -122.333562825344671, 47.607472554078477 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.332910949905937, 47.606757356219816 ], [ -122.332485161894667, 47.606599079567765 ], [ -122.332247428693222, 47.606031697969016 ], [ -122.332941007806582, 47.60541547147222 ], [ -122.33335565945481, 47.605581134829343 ], [ -122.333581233784543, 47.606130706949017 ], [ -122.332910949905937, 47.606757356219816 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.333077205752886, 47.597048524441959 ], [ -122.333071361686606, 47.598737946597353 ], [ -122.332530330676363, 47.598733789665253 ], [ -122.332246158416737, 47.598524846852868 ], [ -122.332248534376347, 47.597820158833642 ], [ -122.332910463183879, 47.59693088165438 ], [ -122.333077205752886, 47.597048524441959 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.13333333333333333 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.33349876710227, 47.600469377271395 ], [ -122.333497653778721, 47.601081221170951 ], [ -122.333234375781018, 47.601310013371197 ], [ -122.332421816926157, 47.601309432902916 ], [ -122.332233320157684, 47.601109653747663 ], [ -122.332235876828378, 47.60046353193448 ], [ -122.332497188046815, 47.60007131730103 ], [ -122.332514909522246, 47.600064627219432 ], [ -122.333239477523449, 47.600076211817971 ], [ -122.33349876710227, 47.600469377271395 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.333385624512417, 47.604238897105986 ], [ -122.332715055650624, 47.604863623919236 ], [ -122.332276212168793, 47.604696732912956 ], [ -122.332043076534788, 47.604155680447477 ], [ -122.332733327250622, 47.603527325635028 ], [ -122.333150097526968, 47.603692209257652 ], [ -122.333385624512417, 47.604238897105986 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.332438830967234, 47.607937992016858 ], [ -122.332015059241755, 47.607764037007755 ], [ -122.331789930937205, 47.607228744498087 ], [ -122.332485161894667, 47.606599079567765 ], [ -122.332910949905937, 47.606757356219816 ], [ -122.333140483081678, 47.607302793302338 ], [ -122.332438830967234, 47.607937992016858 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.332246158416737, 47.598524846852868 ], [ -122.331903769840835, 47.59876500014019 ], [ -122.330980403906125, 47.598741827060046 ], [ -122.330633233628461, 47.597818654362264 ], [ -122.332248534376347, 47.597820158833642 ], [ -122.332246158416737, 47.598524846852868 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.25 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.332497188046815, 47.60007131730103 ], [ -122.331901061747757, 47.599618049459522 ], [ -122.331903769840835, 47.59876500014019 ], [ -122.332246158416737, 47.598524846852868 ], [ -122.332530330676363, 47.598733789665253 ], [ -122.332564136413495, 47.599206282139413 ], [ -122.332514909522246, 47.600064627219432 ], [ -122.332497188046815, 47.60007131730103 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.332421816926157, 47.601309432902916 ], [ -122.333234375781018, 47.601310013371197 ], [ -122.333229234031165, 47.602329608472374 ], [ -122.333216992394071, 47.602332546427583 ], [ -122.332421073249506, 47.601859939556078 ], [ -122.332421816926157, 47.601309432902916 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.332421073249506, 47.601859939556078 ], [ -122.331890685020483, 47.602352540235316 ], [ -122.331125990206615, 47.601944126186666 ], [ -122.331126009850024, 47.601940053536055 ], [ -122.331804635570904, 47.601300039091598 ], [ -122.332233320157684, 47.601109653747663 ], [ -122.332421816926157, 47.601309432902916 ], [ -122.332421073249506, 47.601859939556078 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.333216992394071, 47.602332546427583 ], [ -122.332510528895284, 47.602980868837761 ], [ -122.332084285477322, 47.602816211220478 ], [ -122.331890685020483, 47.602352540235316 ], [ -122.332421073249506, 47.601859939556078 ], [ -122.333216992394071, 47.602332546427583 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.332247428693222, 47.606031697969016 ], [ -122.331843115346445, 47.605877012810147 ], [ -122.331610530208138, 47.605333121409757 ], [ -122.332276212168793, 47.604696732912956 ], [ -122.332715055650624, 47.604863623919236 ], [ -122.332941007806582, 47.60541547147222 ], [ -122.332247428693222, 47.606031697969016 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.331134820106129, 47.608006793077053 ], [ -122.331215837060455, 47.607671965195415 ], [ -122.331729962762395, 47.60720467125229 ], [ -122.331789930937205, 47.607228744498087 ], [ -122.332015059241755, 47.607764037007755 ], [ -122.331528895385389, 47.60822019074952 ], [ -122.331134820106129, 47.608006793077053 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.331528895385389, 47.60822019074952 ], [ -122.331461239955956, 47.608766181934506 ], [ -122.330982467540508, 47.60866708194834 ], [ -122.330671326476718, 47.607999813182886 ], [ -122.330675592312019, 47.607972471012239 ], [ -122.331134820106129, 47.608006793077053 ], [ -122.331528895385389, 47.60822019074952 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.332510528895284, 47.602980868837761 ], [ -122.332733327250622, 47.603527325635028 ], [ -122.332043076534788, 47.604155680447477 ], [ -122.331607223101344, 47.603987551423259 ], [ -122.331388204338722, 47.603450847494358 ], [ -122.332084285477322, 47.602816211220478 ], [ -122.332510528895284, 47.602980868837761 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7142857142857143 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.332438830967234, 47.607937992016858 ], [ -122.33266651907249, 47.608478739181479 ], [ -122.331739490808445, 47.609314754852974 ], [ -122.331461239955956, 47.608766181934506 ], [ -122.331528895385389, 47.60822019074952 ], [ -122.332015059241755, 47.607764037007755 ], [ -122.332438830967234, 47.607937992016858 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.331789930937205, 47.607228744498087 ], [ -122.331729962762395, 47.60720467125229 ], [ -122.331310550071805, 47.606925762652871 ], [ -122.331137980484087, 47.606514270019218 ], [ -122.331843115346445, 47.605877012810147 ], [ -122.332247428693222, 47.606031697969016 ], [ -122.332485161894667, 47.606599079567765 ], [ -122.331789930937205, 47.607228744498087 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.332248534376347, 47.597820158833642 ], [ -122.330633233628461, 47.597818654362264 ], [ -122.330160132568366, 47.597381874367535 ], [ -122.330784835730768, 47.595510255196643 ], [ -122.332525763303025, 47.595787392608081 ], [ -122.332910463183879, 47.59693088165438 ], [ -122.332248534376347, 47.597820158833642 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.331610530208138, 47.605333121409757 ], [ -122.331182684777232, 47.605174010517437 ], [ -122.330951290905688, 47.604608206745681 ], [ -122.331607223101344, 47.603987551423259 ], [ -122.332043076534788, 47.604155680447477 ], [ -122.332276212168793, 47.604696732912956 ], [ -122.331610530208138, 47.605333121409757 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.331804635570904, 47.601300039091598 ], [ -122.331396377409192, 47.600896650063966 ], [ -122.331398781396672, 47.600466127269691 ], [ -122.332235876828378, 47.60046353193448 ], [ -122.332233320157684, 47.601109653747663 ], [ -122.331804635570904, 47.601300039091598 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.332084285477322, 47.602816211220478 ], [ -122.331388204338722, 47.603450847494358 ], [ -122.330962776169301, 47.603271624717237 ], [ -122.330633418237198, 47.602479811676403 ], [ -122.331125990206615, 47.601944126186666 ], [ -122.331890685020483, 47.602352540235316 ], [ -122.332084285477322, 47.602816211220478 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.331610530208138, 47.605333121409757 ], [ -122.331843115346445, 47.605877012810147 ], [ -122.331137980484087, 47.606514270019218 ], [ -122.330818515225914, 47.606381148300763 ], [ -122.33055309641226, 47.605743671462228 ], [ -122.331182684777232, 47.605174010517437 ], [ -122.331610530208138, 47.605333121409757 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.53333333333333333 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.331804635570904, 47.601300039091598 ], [ -122.331126009850024, 47.601940053536055 ], [ -122.330863406181891, 47.601468004837088 ], [ -122.330853967492942, 47.601380460996999 ], [ -122.331396377409192, 47.600896650063966 ], [ -122.331804635570904, 47.601300039091598 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.52380952380952384 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.332235876828378, 47.60046353193448 ], [ -122.331398781396672, 47.600466127269691 ], [ -122.331017193499804, 47.600279371409144 ], [ -122.331019092773687, 47.599647835717107 ], [ -122.331901061747757, 47.599618049459522 ], [ -122.332497188046815, 47.60007131730103 ], [ -122.332235876828378, 47.60046353193448 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.331019092773687, 47.599647835717107 ], [ -122.330923024505211, 47.599516632920171 ], [ -122.330924788419011, 47.598930787398963 ], [ -122.330980403906125, 47.598741827060046 ], [ -122.331903769840835, 47.59876500014019 ], [ -122.331901061747757, 47.599618049459522 ], [ -122.331019092773687, 47.599647835717107 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.330160132568366, 47.597381874367535 ], [ -122.329998135727038, 47.597464463171313 ], [ -122.328720550326722, 47.597469264416524 ], [ -122.328290624874555, 47.596912106049118 ], [ -122.329043316973369, 47.595233023674766 ], [ -122.330784835730768, 47.595510255196643 ], [ -122.330160132568366, 47.597381874367535 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5357142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.331017193499804, 47.600279371409144 ], [ -122.330734288236542, 47.600533541474782 ], [ -122.330358302623736, 47.60046279510486 ], [ -122.330359625939693, 47.599955965101401 ], [ -122.330841739336876, 47.599532171873236 ], [ -122.330923024505211, 47.599516632920171 ], [ -122.331019092773687, 47.599647835717107 ], [ -122.331017193499804, 47.600279371409144 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.331398781396672, 47.600466127269691 ], [ -122.331396377409192, 47.600896650063966 ], [ -122.330853967492942, 47.601380460996999 ], [ -122.330734230763341, 47.601057984615331 ], [ -122.330734288236542, 47.600533541474782 ], [ -122.331017193499804, 47.600279371409144 ], [ -122.331398781396672, 47.600466127269691 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.331126009850024, 47.601940053536055 ], [ -122.331125990206615, 47.601944126186666 ], [ -122.330633418237198, 47.602479811676403 ], [ -122.330430199638982, 47.602480959200982 ], [ -122.3301346, 47.602255030123068 ], [ -122.3301346, 47.601472399648237 ], [ -122.330863406181891, 47.601468004837088 ], [ -122.331126009850024, 47.601940053536055 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.331607223101344, 47.603987551423259 ], [ -122.330951290905688, 47.604608206745681 ], [ -122.330509859125982, 47.604457654956668 ], [ -122.330276092390761, 47.603893731000028 ], [ -122.330962776169301, 47.603271624717237 ], [ -122.331388204338722, 47.603450847494358 ], [ -122.331607223101344, 47.603987551423259 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.331134820106129, 47.608006793077053 ], [ -122.330675592312019, 47.607972471012239 ], [ -122.330449444971521, 47.607606248638213 ], [ -122.330778245346991, 47.607410177311316 ], [ -122.331215837060455, 47.607671965195415 ], [ -122.331134820106129, 47.608006793077053 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.330841739336876, 47.599532171873236 ], [ -122.330613239264437, 47.599534623294382 ], [ -122.329975277061351, 47.599496593537047 ], [ -122.329976480407936, 47.599044962519898 ], [ -122.330924788419011, 47.598930787398963 ], [ -122.330923024505211, 47.599516632920171 ], [ -122.330841739336876, 47.599532171873236 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.41666666666666669 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.330778245346991, 47.607410177311316 ], [ -122.330449444971521, 47.607606248638213 ], [ -122.330245554910888, 47.607528961854733 ], [ -122.330169808550693, 47.607349100932247 ], [ -122.330225238682743, 47.606768578537185 ], [ -122.330818515225914, 47.606381148300763 ], [ -122.331137980484087, 47.606514270019218 ], [ -122.331310550071805, 47.606925762652871 ], [ -122.330778245346991, 47.607410177311316 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.331310550071805, 47.606925762652871 ], [ -122.331729962762395, 47.60720467125229 ], [ -122.331215837060455, 47.607671965195415 ], [ -122.330778245346991, 47.607410177311316 ], [ -122.331310550071805, 47.606925762652871 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.331182684777232, 47.605174010517437 ], [ -122.33055309641226, 47.605743671462228 ], [ -122.330125539376027, 47.605611863350383 ], [ -122.32990340707795, 47.605294968046643 ], [ -122.329886350287978, 47.605253396690848 ], [ -122.329920437473405, 47.605003799106846 ], [ -122.330509859125982, 47.604457654956668 ], [ -122.330951290905688, 47.604608206745681 ], [ -122.331182684777232, 47.605174010517437 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.331739490808445, 47.609314754852974 ], [ -122.331683960541369, 47.609956193581425 ], [ -122.330881970299544, 47.609927513090973 ], [ -122.330719948919651, 47.608765088232389 ], [ -122.330982467540508, 47.60866708194834 ], [ -122.331461239955956, 47.608766181934506 ], [ -122.331739490808445, 47.609314754852974 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.330671326476718, 47.607999813182886 ], [ -122.330232461077529, 47.608710014199893 ], [ -122.330049662277503, 47.608794889731257 ], [ -122.329801755054859, 47.608703207002115 ], [ -122.329569964120211, 47.608153541361013 ], [ -122.330245554910888, 47.607528961854733 ], [ -122.330449444971521, 47.607606248638213 ], [ -122.330675592312019, 47.607972471012239 ], [ -122.330671326476718, 47.607999813182886 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.330962776169301, 47.603271624717237 ], [ -122.330276092390761, 47.603893731000028 ], [ -122.329853434882835, 47.603735731635361 ], [ -122.329628392470141, 47.603191469818135 ], [ -122.330430199638982, 47.602480959200982 ], [ -122.330633418237198, 47.602479811676403 ], [ -122.330962776169301, 47.603271624717237 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.330982467540508, 47.60866708194834 ], [ -122.330719948919651, 47.608765088232389 ], [ -122.330232461077529, 47.608710014199893 ], [ -122.330671326476718, 47.607999813182886 ], [ -122.330982467540508, 47.60866708194834 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.330863406181891, 47.601468004837088 ], [ -122.3301346, 47.601472399648237 ], [ -122.329609613765783, 47.601175030561208 ], [ -122.3296444662992, 47.601045178922426 ], [ -122.330734230763341, 47.601057984615331 ], [ -122.330853967492942, 47.601380460996999 ], [ -122.330863406181891, 47.601468004837088 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.329128208089458, 47.609335875323161 ], [ -122.329801755054859, 47.608703207002115 ], [ -122.330049662277503, 47.608794889731257 ], [ -122.330499715978718, 47.609913843047572 ], [ -122.329352353379733, 47.609872811473444 ], [ -122.329128208089458, 47.609335875323161 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.330881970299544, 47.609927513090973 ], [ -122.330499715978718, 47.609913843047572 ], [ -122.330049662277503, 47.608794889731257 ], [ -122.330232461077529, 47.608710014199893 ], [ -122.330719948919651, 47.608765088232389 ], [ -122.330881970299544, 47.609927513090973 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.330225238682743, 47.606768578537185 ], [ -122.329625437699889, 47.60637498663381 ], [ -122.330125539376027, 47.605611863350383 ], [ -122.33055309641226, 47.605743671462228 ], [ -122.330818515225914, 47.606381148300763 ], [ -122.330225238682743, 47.606768578537185 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.330358302623736, 47.60046279510486 ], [ -122.329647463274782, 47.600458733649241 ], [ -122.329648722691672, 47.600049229408434 ], [ -122.33013576147529, 47.599955189589409 ], [ -122.330359625939693, 47.599955965101401 ], [ -122.330358302623736, 47.60046279510486 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.329920437473405, 47.605003799106846 ], [ -122.329230081144857, 47.604321876883674 ], [ -122.329853434882835, 47.603735731635361 ], [ -122.330276092390761, 47.603893731000028 ], [ -122.330509859125982, 47.604457654956668 ], [ -122.329920437473405, 47.605003799106846 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7142857142857143 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.330734288236542, 47.600533541474782 ], [ -122.330734230763341, 47.601057984615331 ], [ -122.3296444662992, 47.601045178922426 ], [ -122.32964387028575, 47.600464111638672 ], [ -122.329647463274782, 47.600458733649241 ], [ -122.330358302623736, 47.60046279510486 ], [ -122.330734288236542, 47.600533541474782 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.53333333333333333 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.329648722691672, 47.600049229408434 ], [ -122.329609964002799, 47.599832212636301 ], [ -122.329975277061351, 47.599496593537047 ], [ -122.330613239264437, 47.599534623294382 ], [ -122.33013576147529, 47.599955189589409 ], [ -122.329648722691672, 47.600049229408434 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.330359625939693, 47.599955965101401 ], [ -122.33013576147529, 47.599955189589409 ], [ -122.330613239264437, 47.599534623294382 ], [ -122.330841739336876, 47.599532171873236 ], [ -122.330359625939693, 47.599955965101401 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.071428571428571425 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.330924788419011, 47.598930787398963 ], [ -122.329976480407936, 47.599044962519898 ], [ -122.32965323053358, 47.598585808309245 ], [ -122.329998135727038, 47.597464463171313 ], [ -122.330160132568366, 47.597381874367535 ], [ -122.330633233628461, 47.597818654362264 ], [ -122.330980403906125, 47.598741827060046 ], [ -122.330924788419011, 47.598930787398963 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.3301346, 47.601472399648237 ], [ -122.3301346, 47.602255030123068 ], [ -122.329791413349994, 47.602113024767085 ], [ -122.32951942787443, 47.601754866235702 ], [ -122.329519728903676, 47.601280494320051 ], [ -122.329609613765783, 47.601175030561208 ], [ -122.3301346, 47.601472399648237 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.329975277061351, 47.599496593537047 ], [ -122.329609964002799, 47.599832212636301 ], [ -122.329346595576226, 47.599623118284434 ], [ -122.329349225249288, 47.598839475711515 ], [ -122.32965323053358, 47.598585808309245 ], [ -122.329976480407936, 47.599044962519898 ], [ -122.329975277061351, 47.599496593537047 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.330430199638982, 47.602480959200982 ], [ -122.329628392470141, 47.603191469818135 ], [ -122.3292228869567, 47.603031890546227 ], [ -122.329097645757983, 47.602733610123657 ], [ -122.329791413349994, 47.602113024767085 ], [ -122.3301346, 47.602255030123068 ], [ -122.330430199638982, 47.602480959200982 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.41666666666666669 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.329647463274782, 47.600458733649241 ], [ -122.32964387028575, 47.600464111638672 ], [ -122.328340797071206, 47.600457791278821 ], [ -122.328343284011225, 47.599621371172653 ], [ -122.328346315988767, 47.599616528827333 ], [ -122.329346595576226, 47.599623118284434 ], [ -122.329609964002799, 47.599832212636301 ], [ -122.329648722691672, 47.600049229408434 ], [ -122.329647463274782, 47.600458733649241 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5357142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.329519728903676, 47.601280494320051 ], [ -122.328337429171441, 47.601331548172134 ], [ -122.328339700068625, 47.600459523646471 ], [ -122.328340797071206, 47.600457791278821 ], [ -122.32964387028575, 47.600464111638672 ], [ -122.3296444662992, 47.601045178922426 ], [ -122.329609613765783, 47.601175030561208 ], [ -122.329519728903676, 47.601280494320051 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.330225238682743, 47.606768578537185 ], [ -122.330169808550693, 47.607349100932247 ], [ -122.329391950109141, 47.607137377806481 ], [ -122.329427020599638, 47.606412217727737 ], [ -122.329625437699889, 47.60637498663381 ], [ -122.330225238682743, 47.606768578537185 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.32965323053358, 47.598585808309245 ], [ -122.329349225249288, 47.598839475711515 ], [ -122.328348734167932, 47.598803234724166 ], [ -122.328341859729449, 47.598790602287671 ], [ -122.328390143606086, 47.597955919949882 ], [ -122.328720550326722, 47.597469264416524 ], [ -122.329998135727038, 47.597464463171313 ], [ -122.32965323053358, 47.598585808309245 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.330125539376027, 47.605611863350383 ], [ -122.329625437699889, 47.60637498663381 ], [ -122.329427020599638, 47.606412217727737 ], [ -122.329219472899567, 47.606326746737068 ], [ -122.328933423475618, 47.606142802226934 ], [ -122.32990340707795, 47.605294968046643 ], [ -122.330125539376027, 47.605611863350383 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.329853434882835, 47.603735731635361 ], [ -122.329230081144857, 47.604321876883674 ], [ -122.329064266485631, 47.604336025027386 ], [ -122.328740299304044, 47.604197879810215 ], [ -122.328521583751382, 47.6036688383982 ], [ -122.3292228869567, 47.603031890546227 ], [ -122.329628392470141, 47.603191469818135 ], [ -122.329853434882835, 47.603735731635361 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7142857142857143 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.330245554910888, 47.607528961854733 ], [ -122.329569964120211, 47.608153541361013 ], [ -122.329142941150806, 47.607993071465998 ], [ -122.328944675130302, 47.607519972755171 ], [ -122.329391950109141, 47.607137377806481 ], [ -122.330169808550693, 47.607349100932247 ], [ -122.330245554910888, 47.607528961854733 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.328686369777543, 47.609163799220546 ], [ -122.329128208089458, 47.609335875323161 ], [ -122.329352353379733, 47.609872811473444 ], [ -122.3288487, 47.6098548 ], [ -122.328017193030988, 47.609788407970107 ], [ -122.328686369777543, 47.609163799220546 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.32990340707795, 47.605294968046643 ], [ -122.328933423475618, 47.606142802226934 ], [ -122.328913172485656, 47.606135255274147 ], [ -122.328783822472758, 47.605840187351866 ], [ -122.329106194139811, 47.605284175128375 ], [ -122.329886350287978, 47.605253396690848 ], [ -122.32990340707795, 47.605294968046643 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.8 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.32951942787443, 47.601754866235702 ], [ -122.329791413349994, 47.602113024767085 ], [ -122.329097645757983, 47.602733610123657 ], [ -122.328671985492463, 47.602305096329935 ], [ -122.32951942787443, 47.601754866235702 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.328671985492463, 47.602305096329935 ], [ -122.328609772543501, 47.602281451594081 ], [ -122.328237144872759, 47.601496411019781 ], [ -122.328337429171441, 47.601331548172134 ], [ -122.329519728903676, 47.601280494320051 ], [ -122.32951942787443, 47.601754866235702 ], [ -122.328671985492463, 47.602305096329935 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.329569964120211, 47.608153541361013 ], [ -122.329801755054859, 47.608703207002115 ], [ -122.329128208089458, 47.609335875323161 ], [ -122.328686369777543, 47.609163799220546 ], [ -122.328462890256461, 47.608622946070511 ], [ -122.329142941150806, 47.607993071465998 ], [ -122.329569964120211, 47.608153541361013 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.329427020599638, 47.606412217727737 ], [ -122.329391950109141, 47.607137377806481 ], [ -122.328944675130302, 47.607519972755171 ], [ -122.328732561790503, 47.60739872757285 ], [ -122.329219472899567, 47.606326746737068 ], [ -122.329427020599638, 47.606412217727737 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.329886350287978, 47.605253396690848 ], [ -122.329106194139811, 47.605284175128375 ], [ -122.328985468354674, 47.605045671043818 ], [ -122.329064266485631, 47.604336025027386 ], [ -122.329230081144857, 47.604321876883674 ], [ -122.329920437473405, 47.605003799106846 ], [ -122.329886350287978, 47.605253396690848 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.328933423475618, 47.606142802226934 ], [ -122.329219472899567, 47.606326746737068 ], [ -122.328732561790503, 47.60739872757285 ], [ -122.328472482454515, 47.607305779986831 ], [ -122.328235179407045, 47.60673573148572 ], [ -122.328913172485656, 47.606135255274147 ], [ -122.328933423475618, 47.606142802226934 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.41666666666666669 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.329097645757983, 47.602733610123657 ], [ -122.3292228869567, 47.603031890546227 ], [ -122.328521583751382, 47.6036688383982 ], [ -122.328098009402538, 47.603486326145728 ], [ -122.327886346663092, 47.602945793902954 ], [ -122.32788822198269, 47.602941648516101 ], [ -122.328609772543501, 47.602281451594081 ], [ -122.328671985492463, 47.602305096329935 ], [ -122.329097645757983, 47.602733610123657 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.328462890256461, 47.608622946070511 ], [ -122.32802941834359, 47.608452097395563 ], [ -122.327806107486438, 47.607919092645069 ], [ -122.328472482454515, 47.607305779986831 ], [ -122.328732561790503, 47.60739872757285 ], [ -122.328944675130302, 47.607519972755171 ], [ -122.329142941150806, 47.607993071465998 ], [ -122.328462890256461, 47.608622946070511 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.329064266485631, 47.604336025027386 ], [ -122.328985468354674, 47.605045671043818 ], [ -122.328409299374542, 47.605081142084266 ], [ -122.328294750311898, 47.604812114937943 ], [ -122.328268034795386, 47.604617575090955 ], [ -122.328740299304044, 47.604197879810215 ], [ -122.329064266485631, 47.604336025027386 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.328783822472758, 47.605840187351866 ], [ -122.328632777846721, 47.605753976642717 ], [ -122.328362706945569, 47.605382715413192 ], [ -122.328409299374542, 47.605081142084266 ], [ -122.328985468354674, 47.605045671043818 ], [ -122.329106194139811, 47.605284175128375 ], [ -122.328783822472758, 47.605840187351866 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.329349225249288, 47.598839475711515 ], [ -122.329346595576226, 47.599623118284434 ], [ -122.328346315988767, 47.599616528827333 ], [ -122.328348734167932, 47.598803234724166 ], [ -122.329349225249288, 47.598839475711515 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.328609772543501, 47.602281451594081 ], [ -122.32788822198269, 47.602941648516101 ], [ -122.327354774918959, 47.601644067468058 ], [ -122.328237144872759, 47.601496411019781 ], [ -122.328609772543501, 47.602281451594081 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.38095238095238093 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327864629042722, 47.596024850046575 ], [ -122.328408601746077, 47.59519911194846 ], [ -122.3288767, 47.5952065 ], [ -122.329043316973369, 47.595233023674766 ], [ -122.328290624874555, 47.596912106049118 ], [ -122.328153405453492, 47.596872089980273 ], [ -122.327864629042722, 47.596024850046575 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.328153405453492, 47.596872089980273 ], [ -122.327190343980888, 47.596865662753707 ], [ -122.326975558176116, 47.596264647766333 ], [ -122.327061694655768, 47.595957820360837 ], [ -122.327864629042722, 47.596024850046575 ], [ -122.328153405453492, 47.596872089980273 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.328235179407045, 47.60673573148572 ], [ -122.327825046967405, 47.606592952721719 ], [ -122.327596382182477, 47.606044157237996 ], [ -122.328632777846721, 47.605753976642717 ], [ -122.328783822472758, 47.605840187351866 ], [ -122.328913172485656, 47.606135255274147 ], [ -122.328235179407045, 47.60673573148572 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.328237144872759, 47.601496411019781 ], [ -122.327354774918959, 47.601644067468058 ], [ -122.327213459907185, 47.601620779067488 ], [ -122.327016526225876, 47.601308878568489 ], [ -122.327012674781741, 47.600457644129833 ], [ -122.327014309140523, 47.600455135972567 ], [ -122.328339700068625, 47.600459523646471 ], [ -122.328337429171441, 47.601331548172134 ], [ -122.328237144872759, 47.601496411019781 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.328348734167932, 47.598803234724166 ], [ -122.328346315988767, 47.599616528827333 ], [ -122.328343284011225, 47.599621371172653 ], [ -122.327020029638675, 47.59961265408193 ], [ -122.327022557084263, 47.598786684863853 ], [ -122.327025242240097, 47.598782473051365 ], [ -122.328341859729449, 47.598790602287671 ], [ -122.328348734167932, 47.598803234724166 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.32691781031167, 47.608920086003948 ], [ -122.327347899257575, 47.609083101513313 ], [ -122.327631242771631, 47.609757591606424 ], [ -122.3268561, 47.6096957 ], [ -122.326204403958684, 47.609579328535645 ], [ -122.32691781031167, 47.608920086003948 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.328409299374542, 47.605081142084266 ], [ -122.328362706945569, 47.605382715413192 ], [ -122.327917756624274, 47.605430831744101 ], [ -122.327824926170948, 47.605212830212643 ], [ -122.328294750311898, 47.604812114937943 ], [ -122.328409299374542, 47.605081142084266 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.328740299304044, 47.604197879810215 ], [ -122.328268034795386, 47.604617575090955 ], [ -122.327569841888987, 47.604507665684508 ], [ -122.327489919920495, 47.604318576852862 ], [ -122.327646614497056, 47.603883132891781 ], [ -122.328098009402538, 47.603486326145728 ], [ -122.328521583751382, 47.6036688383982 ], [ -122.328740299304044, 47.604197879810215 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.328290624874555, 47.596912106049118 ], [ -122.328720550326722, 47.597469264416524 ], [ -122.328390143606086, 47.597955919949882 ], [ -122.327031147171098, 47.597946272554459 ], [ -122.327033655553663, 47.597105514167168 ], [ -122.327190343980888, 47.596865662753707 ], [ -122.328153405453492, 47.596872089980273 ], [ -122.328290624874555, 47.596912106049118 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327806107486438, 47.607919092645069 ], [ -122.327382772694307, 47.607746636330759 ], [ -122.327159473133221, 47.607202477261062 ], [ -122.327825046967405, 47.606592952721719 ], [ -122.328235179407045, 47.60673573148572 ], [ -122.328472482454515, 47.607305779986831 ], [ -122.327806107486438, 47.607919092645069 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.328686369777543, 47.609163799220546 ], [ -122.328017193030988, 47.609788407970107 ], [ -122.327631242771631, 47.609757591606424 ], [ -122.327347899257575, 47.609083101513313 ], [ -122.32802941834359, 47.608452097395563 ], [ -122.328462890256461, 47.608622946070511 ], [ -122.328686369777543, 47.609163799220546 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.328632777846721, 47.605753976642717 ], [ -122.327596382182477, 47.606044157237996 ], [ -122.327550946134878, 47.605993332735714 ], [ -122.327917756624274, 47.605430831744101 ], [ -122.328362706945569, 47.605382715413192 ], [ -122.328632777846721, 47.605753976642717 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327917756624274, 47.605430831744101 ], [ -122.327550946134878, 47.605993332735714 ], [ -122.327174097372904, 47.605854685925685 ], [ -122.326935909083502, 47.605291912697957 ], [ -122.327432917394489, 47.604861483966964 ], [ -122.327824926170948, 47.605212830212643 ], [ -122.327917756624274, 47.605430831744101 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.13333333333333333 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327824926170948, 47.605212830212643 ], [ -122.327432917394489, 47.604861483966964 ], [ -122.327569841888987, 47.604507665684508 ], [ -122.328268034795386, 47.604617575090955 ], [ -122.328294750311898, 47.604812114937943 ], [ -122.327824926170948, 47.605212830212643 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.328340797071206, 47.600457791278821 ], [ -122.328339700068625, 47.600459523646471 ], [ -122.327014309140523, 47.600455135972567 ], [ -122.327017064908333, 47.599617254379311 ], [ -122.327020029638675, 47.59961265408193 ], [ -122.328343284011225, 47.599621371172653 ], [ -122.328340797071206, 47.600457791278821 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.25 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327596382182477, 47.606044157237996 ], [ -122.327825046967405, 47.606592952721719 ], [ -122.327159473133221, 47.607202477261062 ], [ -122.326728104745655, 47.607034410231726 ], [ -122.326499012486678, 47.606484470670587 ], [ -122.327174097372904, 47.605854685925685 ], [ -122.327550946134878, 47.605993332735714 ], [ -122.327596382182477, 47.606044157237996 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.328098009402538, 47.603486326145728 ], [ -122.327646614497056, 47.603883132891781 ], [ -122.326971925972146, 47.603425949322805 ], [ -122.327490279254434, 47.602952113043287 ], [ -122.327886346663092, 47.602945793902954 ], [ -122.328098009402538, 47.603486326145728 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.328341859729449, 47.598790602287671 ], [ -122.327025242240097, 47.598782473051365 ], [ -122.327027785619123, 47.597951423951699 ], [ -122.327031147171098, 47.597946272554459 ], [ -122.328390143606086, 47.597955919949882 ], [ -122.328341859729449, 47.598790602287671 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327489919920495, 47.604318576852862 ], [ -122.326341484167983, 47.604072945742892 ], [ -122.326819683163592, 47.603452760490896 ], [ -122.326971925972146, 47.603425949322805 ], [ -122.327646614497056, 47.603883132891781 ], [ -122.327489919920495, 47.604318576852862 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327806107486438, 47.607919092645069 ], [ -122.32802941834359, 47.608452097395563 ], [ -122.327347899257575, 47.609083101513313 ], [ -122.32691781031167, 47.608920086003948 ], [ -122.326692607750843, 47.608373342306066 ], [ -122.327382772694307, 47.607746636330759 ], [ -122.327806107486438, 47.607919092645069 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327025242240097, 47.598782473051365 ], [ -122.327022557084263, 47.598786684863853 ], [ -122.325704968054595, 47.598778230600104 ], [ -122.325707460089518, 47.597947386154182 ], [ -122.325710658749372, 47.597942384387338 ], [ -122.327027785619123, 47.597951423951699 ], [ -122.327025242240097, 47.598782473051365 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327020029638675, 47.59961265408193 ], [ -122.327017064908333, 47.599617254379311 ], [ -122.325699606072192, 47.599608256637438 ], [ -122.325702081611453, 47.598782849952414 ], [ -122.325704968054595, 47.598778230600104 ], [ -122.327022557084263, 47.598786684863853 ], [ -122.327020029638675, 47.59961265408193 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327490279254434, 47.602952113043287 ], [ -122.326971925972146, 47.603425949322805 ], [ -122.326819683163592, 47.603452760490896 ], [ -122.326633159135099, 47.602983720439795 ], [ -122.32675208304039, 47.602364911509426 ], [ -122.327490279254434, 47.602952113043287 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.32675208304039, 47.602364911509426 ], [ -122.326729023399224, 47.602296722085441 ], [ -122.327213459907185, 47.601620779067488 ], [ -122.327354774918959, 47.601644067468058 ], [ -122.32788822198269, 47.602941648516101 ], [ -122.327886346663092, 47.602945793902954 ], [ -122.327490279254434, 47.602952113043287 ], [ -122.32675208304039, 47.602364911509426 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.326729023399224, 47.602296722085441 ], [ -122.325624108277097, 47.602243493168125 ], [ -122.325294988509214, 47.60215356153055 ], [ -122.325384687268013, 47.60182389586425 ], [ -122.325751304557514, 47.601289564547407 ], [ -122.327016526225876, 47.601308878568489 ], [ -122.327213459907185, 47.601620779067488 ], [ -122.326729023399224, 47.602296722085441 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327432917394489, 47.604861483966964 ], [ -122.326935909083502, 47.605291912697957 ], [ -122.326532653914583, 47.605129086996236 ], [ -122.326225571622956, 47.604395256363574 ], [ -122.326299066998857, 47.604091900046122 ], [ -122.326341484167983, 47.604072945742892 ], [ -122.327489919920495, 47.604318576852862 ], [ -122.327569841888987, 47.604507665684508 ], [ -122.327432917394489, 47.604861483966964 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327027785619123, 47.597951423951699 ], [ -122.325710658749372, 47.597942384387338 ], [ -122.325713243596255, 47.59710155260445 ], [ -122.325716287952687, 47.597096798124454 ], [ -122.327033655553663, 47.597105514167168 ], [ -122.327031147171098, 47.597946272554459 ], [ -122.327027785619123, 47.597951423951699 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327159473133221, 47.607202477261062 ], [ -122.327382772694307, 47.607746636330759 ], [ -122.326692607750843, 47.608373342306066 ], [ -122.326270443642585, 47.608206326350867 ], [ -122.326043270005655, 47.607663979287082 ], [ -122.326728104745655, 47.607034410231726 ], [ -122.327159473133221, 47.607202477261062 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327033655553663, 47.597105514167168 ], [ -122.325716287952687, 47.597096798124454 ], [ -122.325718791740854, 47.596261972549513 ], [ -122.325722404934055, 47.596256239357317 ], [ -122.326975558176116, 47.596264647766333 ], [ -122.327190343980888, 47.596865662753707 ], [ -122.327033655553663, 47.597105514167168 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.38095238095238093 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327061694655768, 47.595957820360837 ], [ -122.326975558176116, 47.596264647766333 ], [ -122.325722404934055, 47.596256239357317 ], [ -122.325723906601652, 47.595421750160426 ], [ -122.3267225, 47.5951725 ], [ -122.327044781231521, 47.595177586603775 ], [ -122.327061694655768, 47.595957820360837 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.326499012486678, 47.606484470670587 ], [ -122.326072601870166, 47.606323409433251 ], [ -122.325834632091443, 47.605761079728026 ], [ -122.326532653914583, 47.605129086996236 ], [ -122.326935909083502, 47.605291912697957 ], [ -122.327174097372904, 47.605854685925685 ], [ -122.326499012486678, 47.606484470670587 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.326341484167983, 47.604072945742892 ], [ -122.326299066998857, 47.604091900046122 ], [ -122.325920822679223, 47.60375177423677 ], [ -122.326209664999297, 47.603057722765591 ], [ -122.326633159135099, 47.602983720439795 ], [ -122.326819683163592, 47.603452760490896 ], [ -122.326341484167983, 47.604072945742892 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.32515657468835, 47.608669738047162 ], [ -122.325580922585104, 47.608843549782073 ], [ -122.325860824696548, 47.609517976587306 ], [ -122.324478444500826, 47.60927112898127 ], [ -122.32515657468835, 47.608669738047162 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.326692607750843, 47.608373342306066 ], [ -122.32691781031167, 47.608920086003948 ], [ -122.326204403958684, 47.609579328535645 ], [ -122.325860824696548, 47.609517976587306 ], [ -122.325580922585104, 47.608843549782073 ], [ -122.326270443642585, 47.608206326350867 ], [ -122.326692607750843, 47.608373342306066 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.326499012486678, 47.606484470670587 ], [ -122.326728104745655, 47.607034410231726 ], [ -122.326043270005655, 47.607663979287082 ], [ -122.325614351252327, 47.607500183186687 ], [ -122.325383850621165, 47.606947021482078 ], [ -122.326072601870166, 47.606323409433251 ], [ -122.326499012486678, 47.606484470670587 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.325722404934055, 47.596256239357317 ], [ -122.325718791740854, 47.596261972549513 ], [ -122.3244016882729, 47.596253118072418 ], [ -122.324127016414238, 47.595820335947245 ], [ -122.325723906601652, 47.595421750160426 ], [ -122.325722404934055, 47.596256239357317 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.325699606072192, 47.599608256637438 ], [ -122.325696350946856, 47.599613411426887 ], [ -122.324719736436606, 47.599606860892379 ], [ -122.324722256870288, 47.598776444318524 ], [ -122.325702081611453, 47.598782849952414 ], [ -122.325699606072192, 47.599608256637438 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.325753551710037, 47.600458526692726 ], [ -122.327012674781741, 47.600457644129833 ], [ -122.327016526225876, 47.601308878568489 ], [ -122.325751304557514, 47.601289564547407 ], [ -122.325753551710037, 47.600458526692726 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.26666666666666666 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.325751304557514, 47.601289564547407 ], [ -122.325384687268013, 47.60182389586425 ], [ -122.324521970480831, 47.600529456257917 ], [ -122.325694241615864, 47.600373682723138 ], [ -122.325753551710037, 47.600458526692726 ], [ -122.325751304557514, 47.601289564547407 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327012674781741, 47.600457644129833 ], [ -122.325753551710037, 47.600458526692726 ], [ -122.325694241615864, 47.600373682723138 ], [ -122.325696350946856, 47.599613411426887 ], [ -122.325699606072192, 47.599608256637438 ], [ -122.327017064908333, 47.599617254379311 ], [ -122.327014309140523, 47.600455135972567 ], [ -122.327012674781741, 47.600457644129833 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.325624108277097, 47.602243493168125 ], [ -122.326729023399224, 47.602296722085441 ], [ -122.32675208304039, 47.602364911509426 ], [ -122.326633159135099, 47.602983720439795 ], [ -122.326209664999297, 47.603057722765591 ], [ -122.325624108277097, 47.602243493168125 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.326209664999297, 47.603057722765591 ], [ -122.325920822679223, 47.60375177423677 ], [ -122.325015181821456, 47.603344459142619 ], [ -122.325143530136202, 47.602266709066733 ], [ -122.325294988509214, 47.60215356153055 ], [ -122.325624108277097, 47.602243493168125 ], [ -122.326209664999297, 47.603057722765591 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.326532653914583, 47.605129086996236 ], [ -122.325834632091443, 47.605761079728026 ], [ -122.325417735271444, 47.605603064375181 ], [ -122.325126542938108, 47.604919532594636 ], [ -122.326225571622956, 47.604395256363574 ], [ -122.326532653914583, 47.605129086996236 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.326225571622956, 47.604395256363574 ], [ -122.325126542938108, 47.604919532594636 ], [ -122.324885241683816, 47.604790783563558 ], [ -122.324465257979284, 47.603859608620759 ], [ -122.325015181821456, 47.603344459142619 ], [ -122.325920822679223, 47.60375177423677 ], [ -122.326299066998857, 47.604091900046122 ], [ -122.326225571622956, 47.604395256363574 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.325294988509214, 47.60215356153055 ], [ -122.325143530136202, 47.602266709066733 ], [ -122.324134533395792, 47.601975173891582 ], [ -122.324137607625019, 47.600652836114548 ], [ -122.324376841513853, 47.600479263078263 ], [ -122.324521970480831, 47.600529456257917 ], [ -122.325384687268013, 47.60182389586425 ], [ -122.325294988509214, 47.60215356153055 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.325707460089518, 47.597947386154182 ], [ -122.324393540056136, 47.597938525122245 ], [ -122.324396061990413, 47.597097492376108 ], [ -122.324399105653086, 47.597092856902584 ], [ -122.325713243596255, 47.59710155260445 ], [ -122.325710658749372, 47.597942384387338 ], [ -122.325707460089518, 47.597947386154182 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.326043270005655, 47.607663979287082 ], [ -122.326270443642585, 47.608206326350867 ], [ -122.325580922585104, 47.608843549782073 ], [ -122.32515657468835, 47.608669738047162 ], [ -122.324938517527301, 47.608124741557141 ], [ -122.325614351252327, 47.607500183186687 ], [ -122.326043270005655, 47.607663979287082 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.325713243596255, 47.59710155260445 ], [ -122.324399105653086, 47.597092856902584 ], [ -122.3244016882729, 47.596253118072418 ], [ -122.325718791740854, 47.596261972549513 ], [ -122.325716287952687, 47.597096798124454 ], [ -122.325713243596255, 47.59710155260445 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.326072601870166, 47.606323409433251 ], [ -122.325383850621165, 47.606947021482078 ], [ -122.324971028626763, 47.606786180836977 ], [ -122.324735884026822, 47.606232133934512 ], [ -122.325417735271444, 47.605603064375181 ], [ -122.325834632091443, 47.605761079728026 ], [ -122.326072601870166, 47.606323409433251 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324938517527301, 47.608124741557141 ], [ -122.324832898971238, 47.608083375425025 ], [ -122.324478568714426, 47.6078188425235 ], [ -122.324300059380121, 47.607389414319556 ], [ -122.324971028626763, 47.606786180836977 ], [ -122.325383850621165, 47.606947021482078 ], [ -122.325614351252327, 47.607500183186687 ], [ -122.324938517527301, 47.608124741557141 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324735884026822, 47.606232133934512 ], [ -122.324318176775989, 47.606074227989552 ], [ -122.32408677110945, 47.605516122977477 ], [ -122.324885241683816, 47.604790783563558 ], [ -122.325126542938108, 47.604919532594636 ], [ -122.325417735271444, 47.605603064375181 ], [ -122.324735884026822, 47.606232133934512 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.325704968054595, 47.598778230600104 ], [ -122.325702081611453, 47.598782849952414 ], [ -122.324722256870288, 47.598776444318524 ], [ -122.324388678231472, 47.598520866654958 ], [ -122.324390410270894, 47.597943298127689 ], [ -122.324393540056136, 47.597938525122245 ], [ -122.325707460089518, 47.597947386154182 ], [ -122.325704968054595, 47.598778230600104 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.25 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323492124344313, 47.608721704968055 ], [ -122.32397255766449, 47.608212868394759 ], [ -122.324478568714426, 47.6078188425235 ], [ -122.324832898971238, 47.608083375425025 ], [ -122.323669975788334, 47.609126763077541 ], [ -122.3235649, 47.609108 ], [ -122.323493167703745, 47.60907978592661 ], [ -122.323492124344313, 47.608721704968055 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.26666666666666666 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.322729472584015, 47.607719398169856 ], [ -122.323147784799218, 47.607876515002744 ], [ -122.323492124344313, 47.608721704968055 ], [ -122.323493167703745, 47.60907978592661 ], [ -122.321920514496512, 47.608461222806113 ], [ -122.322729472584015, 47.607719398169856 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324722256870288, 47.598776444318524 ], [ -122.324719736436606, 47.599606860892379 ], [ -122.324378556129531, 47.599859810536856 ], [ -122.324108440480117, 47.599639296056864 ], [ -122.324068714764024, 47.599200427671029 ], [ -122.324097224423141, 47.598756388083899 ], [ -122.324388678231472, 47.598520866654958 ], [ -122.324722256870288, 47.598776444318524 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324719736436606, 47.599606860892379 ], [ -122.325696350946856, 47.599613411426887 ], [ -122.325694241615864, 47.600373682723138 ], [ -122.324521970480831, 47.600529456257917 ], [ -122.324376841513853, 47.600479263078263 ], [ -122.324378556129531, 47.599859810536856 ], [ -122.324719736436606, 47.599606860892379 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324938517527301, 47.608124741557141 ], [ -122.32515657468835, 47.608669738047162 ], [ -122.324478444500826, 47.60927112898127 ], [ -122.323669975788334, 47.609126763077541 ], [ -122.324832898971238, 47.608083375425025 ], [ -122.324938517527301, 47.608124741557141 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.325015181821456, 47.603344459142619 ], [ -122.324465257979284, 47.603859608620759 ], [ -122.323766801840989, 47.603846000293146 ], [ -122.323182599347604, 47.602463418424492 ], [ -122.323363163919183, 47.602204189117899 ], [ -122.324134533395792, 47.601975173891582 ], [ -122.325143530136202, 47.602266709066733 ], [ -122.325015181821456, 47.603344459142619 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324735884026822, 47.606232133934512 ], [ -122.324971028626763, 47.606786180836977 ], [ -122.324300059380121, 47.607389414319556 ], [ -122.32389062261845, 47.607244183101187 ], [ -122.323651490568864, 47.606670635162871 ], [ -122.324318176775989, 47.606074227989552 ], [ -122.324735884026822, 47.606232133934512 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324393540056136, 47.597938525122245 ], [ -122.324390410270894, 47.597943298127689 ], [ -122.323096233333757, 47.597934723363302 ], [ -122.323098768492827, 47.597093570585471 ], [ -122.323101831507159, 47.597088929414504 ], [ -122.324396061990413, 47.597097492376108 ], [ -122.324393540056136, 47.597938525122245 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324885241683816, 47.604790783563558 ], [ -122.32408677110945, 47.605516122977477 ], [ -122.323668258868167, 47.605353606183002 ], [ -122.323414657931082, 47.604743830397794 ], [ -122.323714247745997, 47.603894194469852 ], [ -122.323766801840989, 47.603846000293146 ], [ -122.324465257979284, 47.603859608620759 ], [ -122.324885241683816, 47.604790783563558 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5357142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324396061990413, 47.597097492376108 ], [ -122.323101831507159, 47.597088929414504 ], [ -122.323104304134219, 47.596268524448291 ], [ -122.3236504, 47.5959393 ], [ -122.324127016414238, 47.595820335947245 ], [ -122.3244016882729, 47.596253118072418 ], [ -122.324399105653086, 47.597092856902584 ], [ -122.324396061990413, 47.597097492376108 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324388678231472, 47.598520866654958 ], [ -122.324097224423141, 47.598756388083899 ], [ -122.323090724755772, 47.598749590010456 ], [ -122.32309316666624, 47.597939376636695 ], [ -122.323096233333757, 47.597934723363302 ], [ -122.324390410270894, 47.597943298127689 ], [ -122.324388678231472, 47.598520866654958 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324108440480117, 47.599639296056864 ], [ -122.323594550490853, 47.599635835069996 ], [ -122.323078349436273, 47.599452457539911 ], [ -122.323087312221375, 47.599194787426605 ], [ -122.324068714764024, 47.599200427671029 ], [ -122.324108440480117, 47.599639296056864 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323492124344313, 47.608721704968055 ], [ -122.323147784799218, 47.607876515002744 ], [ -122.323384619601711, 47.607659977469417 ], [ -122.323657636165109, 47.607457056796328 ], [ -122.32397255766449, 47.608212868394759 ], [ -122.323492124344313, 47.608721704968055 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324478568714426, 47.6078188425235 ], [ -122.32397255766449, 47.608212868394759 ], [ -122.323657636165109, 47.607457056796328 ], [ -122.32389062261845, 47.607244183101187 ], [ -122.324300059380121, 47.607389414319556 ], [ -122.324478568714426, 47.6078188425235 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324318176775989, 47.606074227989552 ], [ -122.323651490568864, 47.606670635162871 ], [ -122.323199521014374, 47.606512616314873 ], [ -122.322976436674622, 47.605986266461649 ], [ -122.323668258868167, 47.605353606183002 ], [ -122.32408677110945, 47.605516122977477 ], [ -122.324318176775989, 47.606074227989552 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324068714764024, 47.599200427671029 ], [ -122.323087312221375, 47.599194787426605 ], [ -122.323068544036573, 47.598785836894585 ], [ -122.323090724755772, 47.598749590010456 ], [ -122.324097224423141, 47.598756388083899 ], [ -122.324068714764024, 47.599200427671029 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324376841513853, 47.600479263078263 ], [ -122.324137607625019, 47.600652836114548 ], [ -122.323591610384341, 47.600623710859814 ], [ -122.323594550490853, 47.599635835069996 ], [ -122.324108440480117, 47.599639296056864 ], [ -122.324378556129531, 47.599859810536856 ], [ -122.324376841513853, 47.600479263078263 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323657636165109, 47.607457056796328 ], [ -122.323384619601711, 47.607659977469417 ], [ -122.32300122569039, 47.606718644524072 ], [ -122.323199521014374, 47.606512616314873 ], [ -122.323651490568864, 47.606670635162871 ], [ -122.32389062261845, 47.607244183101187 ], [ -122.323657636165109, 47.607457056796328 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323147784799218, 47.607876515002744 ], [ -122.322729472584015, 47.607719398169856 ], [ -122.322491573412634, 47.607155189220336 ], [ -122.32300122569039, 47.606718644524072 ], [ -122.323384619601711, 47.607659977469417 ], [ -122.323147784799218, 47.607876515002744 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323101831507159, 47.597088929414504 ], [ -122.323098768492827, 47.597093570585471 ], [ -122.322068016138246, 47.597086750862914 ], [ -122.321940803520391, 47.596969963282866 ], [ -122.323104304134219, 47.596268524448291 ], [ -122.323101831507159, 47.597088929414504 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323090724755772, 47.598749590010456 ], [ -122.323068544036573, 47.598785836894585 ], [ -122.321811510430493, 47.598777535729269 ], [ -122.322027886421125, 47.597965479554851 ], [ -122.322064494222218, 47.597932561012364 ], [ -122.32309316666624, 47.597939376636695 ], [ -122.323090724755772, 47.598749590010456 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.32309316666624, 47.597939376636695 ], [ -122.322064494222218, 47.597932561012364 ], [ -122.322068016138246, 47.597086750862914 ], [ -122.323098768492827, 47.597093570585471 ], [ -122.323096233333757, 47.597934723363302 ], [ -122.32309316666624, 47.597939376636695 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323087312221375, 47.599194787426605 ], [ -122.323078349436273, 47.599452457539911 ], [ -122.322275844154561, 47.600454925548924 ], [ -122.322022950443895, 47.600459574181123 ], [ -122.321732534328021, 47.599373609867278 ], [ -122.321736861462341, 47.598842802181501 ], [ -122.321811510430493, 47.598777535729269 ], [ -122.323068544036573, 47.598785836894585 ], [ -122.323087312221375, 47.599194787426605 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324134533395792, 47.601975173891582 ], [ -122.323363163919183, 47.602204189117899 ], [ -122.322796262018969, 47.60075745939848 ], [ -122.323591610384341, 47.600623710859814 ], [ -122.324137607625019, 47.600652836114548 ], [ -122.324134533395792, 47.601975173891582 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.066666666666666666 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323591610384341, 47.600623710859814 ], [ -122.322796262018969, 47.60075745939848 ], [ -122.322275844154561, 47.600454925548924 ], [ -122.323078349436273, 47.599452457539911 ], [ -122.323594550490853, 47.599635835069996 ], [ -122.323591610384341, 47.600623710859814 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7142857142857143 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323668258868167, 47.605353606183002 ], [ -122.322976436674622, 47.605986266461649 ], [ -122.322556125783208, 47.605816209151087 ], [ -122.322327740543543, 47.605270958137304 ], [ -122.32274281297542, 47.604889368599771 ], [ -122.323414657931082, 47.604743830397794 ], [ -122.323668258868167, 47.605353606183002 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.32300122569039, 47.606718644524072 ], [ -122.322491573412634, 47.607155189220336 ], [ -122.322096215230474, 47.60700446812411 ], [ -122.321862415293936, 47.606449117497021 ], [ -122.322556125783208, 47.605816209151087 ], [ -122.322976436674622, 47.605986266461649 ], [ -122.323199521014374, 47.606512616314873 ], [ -122.32300122569039, 47.606718644524072 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323414657931082, 47.604743830397794 ], [ -122.32274281297542, 47.604889368599771 ], [ -122.322348100288693, 47.603947426732176 ], [ -122.322362067280281, 47.603917653919481 ], [ -122.323714247745997, 47.603894194469852 ], [ -122.323414657931082, 47.604743830397794 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323363163919183, 47.602204189117899 ], [ -122.323182599347604, 47.602463418424492 ], [ -122.323121704523999, 47.602474244484576 ], [ -122.321623787382364, 47.601974053738417 ], [ -122.321624291970224, 47.600732479301428 ], [ -122.322022950443895, 47.600459574181123 ], [ -122.322275844154561, 47.600454925548924 ], [ -122.322796262018969, 47.60075745939848 ], [ -122.323363163919183, 47.602204189117899 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323714247745997, 47.603894194469852 ], [ -122.322362067280281, 47.603917653919481 ], [ -122.322132531225691, 47.603373860132805 ], [ -122.323121704523999, 47.602474244484576 ], [ -122.323182599347604, 47.602463418424492 ], [ -122.323766801840989, 47.603846000293146 ], [ -122.323714247745997, 47.603894194469852 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.322327740543543, 47.605270958137304 ], [ -122.321898677421629, 47.60510305760743 ], [ -122.321671443201808, 47.604554761224151 ], [ -122.322348100288693, 47.603947426732176 ], [ -122.32274281297542, 47.604889368599771 ], [ -122.322327740543543, 47.605270958137304 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.321350228104947, 47.607679453409233 ], [ -122.322096215230474, 47.60700446812411 ], [ -122.322491573412634, 47.607155189220336 ], [ -122.322729472584015, 47.607719398169856 ], [ -122.321920514496512, 47.608461222806113 ], [ -122.321184299201349, 47.608171651253897 ], [ -122.321350228104947, 47.607679453409233 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320007681427683, 47.606841588308193 ], [ -122.320998084184197, 47.606851497483397 ], [ -122.321350228104947, 47.607679453409233 ], [ -122.321184299201349, 47.608171651253897 ], [ -122.3211351, 47.6081523 ], [ -122.320961, 47.608047 ], [ -122.319909132971475, 47.606972211770618 ], [ -122.320007681427683, 47.606841588308193 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.322327740543543, 47.605270958137304 ], [ -122.322556125783208, 47.605816209151087 ], [ -122.321862415293936, 47.606449117497021 ], [ -122.321457035439352, 47.606293404103653 ], [ -122.321227324862406, 47.605713192889567 ], [ -122.321898677421629, 47.60510305760743 ], [ -122.322327740543543, 47.605270958137304 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.322348100288693, 47.603947426732176 ], [ -122.321671443201808, 47.604554761224151 ], [ -122.321414290868105, 47.604448320960948 ], [ -122.321376975512479, 47.604400244385651 ], [ -122.321181798589507, 47.603874961155675 ], [ -122.321460947876105, 47.603121858228548 ], [ -122.322132531225691, 47.603373860132805 ], [ -122.322362067280281, 47.603917653919481 ], [ -122.322348100288693, 47.603947426732176 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.321811510430493, 47.598777535729269 ], [ -122.321736861462341, 47.598842802181501 ], [ -122.320455117296717, 47.598325426616853 ], [ -122.321594382598605, 47.597810157247928 ], [ -122.322027886421125, 47.597965479554851 ], [ -122.321811510430493, 47.598777535729269 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.322022950443895, 47.600459574181123 ], [ -122.321624291970224, 47.600732479301428 ], [ -122.320503790029278, 47.600587577221241 ], [ -122.320382710801411, 47.600437364485444 ], [ -122.320330873646242, 47.599403893741986 ], [ -122.320331536007217, 47.599401506653066 ], [ -122.321732534328021, 47.599373609867278 ], [ -122.322022950443895, 47.600459574181123 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.322132531225691, 47.603373860132805 ], [ -122.321460947876105, 47.603121858228548 ], [ -122.321455952799909, 47.60311356868251 ], [ -122.32146048524514, 47.602196348411169 ], [ -122.321623787382364, 47.601974053738417 ], [ -122.323121704523999, 47.602474244484576 ], [ -122.322132531225691, 47.603373860132805 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.047619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.322027886421125, 47.597965479554851 ], [ -122.321594382598605, 47.597810157247928 ], [ -122.321341701113539, 47.597331143748988 ], [ -122.321940803520391, 47.596969963282866 ], [ -122.322068016138246, 47.597086750862914 ], [ -122.322064494222218, 47.597932561012364 ], [ -122.322027886421125, 47.597965479554851 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320998084184197, 47.606851497483397 ], [ -122.32136027020195, 47.606375068826743 ], [ -122.321457035439352, 47.606293404103653 ], [ -122.321862415293936, 47.606449117497021 ], [ -122.322096215230474, 47.60700446812411 ], [ -122.321350228104947, 47.607679453409233 ], [ -122.320998084184197, 47.606851497483397 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.321227324862406, 47.605713192889567 ], [ -122.32121335016933, 47.605708082414864 ], [ -122.320920873339119, 47.604903163751828 ], [ -122.321414290868105, 47.604448320960948 ], [ -122.321671443201808, 47.604554761224151 ], [ -122.321898677421629, 47.60510305760743 ], [ -122.321227324862406, 47.605713192889567 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.321732534328021, 47.599373609867278 ], [ -122.320331536007217, 47.599401506653066 ], [ -122.32033319089274, 47.598303371894751 ], [ -122.320455117296717, 47.598325426616853 ], [ -122.321736861462341, 47.598842802181501 ], [ -122.321732534328021, 47.599373609867278 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.321594382598605, 47.597810157247928 ], [ -122.320455117296717, 47.598325426616853 ], [ -122.32033319089274, 47.598303371894751 ], [ -122.320122152204888, 47.598066372381481 ], [ -122.321341701113539, 47.597331143748988 ], [ -122.321594382598605, 47.597810157247928 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.321455952799909, 47.60311356868251 ], [ -122.320427057346777, 47.603125091716862 ], [ -122.320096435142148, 47.602841465585605 ], [ -122.320098711268869, 47.602284518063151 ], [ -122.320166265485881, 47.602205580016346 ], [ -122.32146048524514, 47.602196348411169 ], [ -122.321455952799909, 47.60311356868251 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.8 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320998084184197, 47.606851497483397 ], [ -122.320007681427683, 47.606841588308193 ], [ -122.320109561652899, 47.606292015881898 ], [ -122.32136027020195, 47.606375068826743 ], [ -122.320998084184197, 47.606851497483397 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.32033319089274, 47.598303371894751 ], [ -122.320331536007217, 47.599401506653066 ], [ -122.320330873646242, 47.599403893741986 ], [ -122.318763399065787, 47.599443550677954 ], [ -122.31978190000001, 47.59827150000001 ], [ -122.320122152204888, 47.598066372381481 ], [ -122.32033319089274, 47.598303371894751 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320920873339119, 47.604903163751828 ], [ -122.320279042678322, 47.6049016161775 ], [ -122.320771020457215, 47.604407467908395 ], [ -122.321376975512479, 47.604400244385651 ], [ -122.321414290868105, 47.604448320960948 ], [ -122.320920873339119, 47.604903163751828 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.321457035439352, 47.606293404103653 ], [ -122.32136027020195, 47.606375068826743 ], [ -122.320109561652899, 47.606292015881898 ], [ -122.320108771446328, 47.605718284326564 ], [ -122.32121335016933, 47.605708082414864 ], [ -122.321227324862406, 47.605713192889567 ], [ -122.321457035439352, 47.606293404103653 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.321376975512479, 47.604400244385651 ], [ -122.320771020457215, 47.604407467908395 ], [ -122.320375757101246, 47.603927453959997 ], [ -122.320417815714563, 47.603883755363327 ], [ -122.321181798589507, 47.603874961155675 ], [ -122.321376975512479, 47.604400244385651 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.321181798589507, 47.603874961155675 ], [ -122.320417815714563, 47.603883755363327 ], [ -122.320427057346777, 47.603125091716862 ], [ -122.321455952799909, 47.60311356868251 ], [ -122.321460947876105, 47.603121858228548 ], [ -122.321181798589507, 47.603874961155675 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.31999524977617, 47.60478562920855 ], [ -122.318214308595003, 47.604798991039466 ], [ -122.318171778504848, 47.603852491568844 ], [ -122.318673755324909, 47.603681220491957 ], [ -122.319400084537691, 47.603686641652473 ], [ -122.320004826096778, 47.604152401770634 ], [ -122.31999524977617, 47.60478562920855 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320004826096778, 47.604152401770634 ], [ -122.320375757101246, 47.603927453959997 ], [ -122.320771020457215, 47.604407467908395 ], [ -122.320279042678322, 47.6049016161775 ], [ -122.320107053171441, 47.604943962946294 ], [ -122.31999524977617, 47.60478562920855 ], [ -122.320004826096778, 47.604152401770634 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.32121335016933, 47.605708082414864 ], [ -122.320108771446328, 47.605718284326564 ], [ -122.32010474818513, 47.605712760203481 ], [ -122.320107053171441, 47.604943962946294 ], [ -122.320279042678322, 47.6049016161775 ], [ -122.320920873339119, 47.604903163751828 ], [ -122.32121335016933, 47.605708082414864 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7142857142857143 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.32146048524514, 47.602196348411169 ], [ -122.320166265485881, 47.602205580016346 ], [ -122.320175333020188, 47.601142523840387 ], [ -122.320503790029278, 47.600587577221241 ], [ -122.321624291970224, 47.600732479301428 ], [ -122.321623787382364, 47.601974053738417 ], [ -122.32146048524514, 47.602196348411169 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320107053171441, 47.604943962946294 ], [ -122.32010474818513, 47.605712760203481 ], [ -122.318672624576536, 47.605708758660619 ], [ -122.3182351, 47.6052617 ], [ -122.318214308595003, 47.604798991039466 ], [ -122.31999524977617, 47.60478562920855 ], [ -122.320107053171441, 47.604943962946294 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320375757101246, 47.603927453959997 ], [ -122.320004826096778, 47.604152401770634 ], [ -122.319400084537691, 47.603686641652473 ], [ -122.320089344854111, 47.602846959015977 ], [ -122.320096435142148, 47.602841465585605 ], [ -122.320427057346777, 47.603125091716862 ], [ -122.320417815714563, 47.603883755363327 ], [ -122.320375757101246, 47.603927453959997 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.32010474818513, 47.605712760203481 ], [ -122.320108771446328, 47.605718284326564 ], [ -122.320109561652899, 47.606292015881898 ], [ -122.320007681427683, 47.606841588308193 ], [ -122.319909132971475, 47.606972211770618 ], [ -122.318672624576536, 47.605708758660619 ], [ -122.32010474818513, 47.605712760203481 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6071428571428571 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320503790029278, 47.600587577221241 ], [ -122.320175333020188, 47.601142523840387 ], [ -122.318899748490111, 47.60141879584009 ], [ -122.318170574429232, 47.600354183662319 ], [ -122.318191500000012, 47.600104 ], [ -122.318256652563079, 47.600027573427418 ], [ -122.320382710801411, 47.600437364485444 ], [ -122.320503790029278, 47.600587577221241 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320382710801411, 47.600437364485444 ], [ -122.318256652563079, 47.600027573427418 ], [ -122.3182961, 47.5999813 ], [ -122.318763399065787, 47.599443550677954 ], [ -122.320330873646242, 47.599403893741986 ], [ -122.320382710801411, 47.600437364485444 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.319400084537691, 47.603686641652473 ], [ -122.318673755324909, 47.603681220491957 ], [ -122.318991659870932, 47.60310131431573 ], [ -122.319270167039917, 47.602853177197375 ], [ -122.320089344854111, 47.602846959015977 ], [ -122.319400084537691, 47.603686641652473 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320098711268869, 47.602284518063151 ], [ -122.319317889035275, 47.602165546628157 ], [ -122.319049024523892, 47.602046610184679 ], [ -122.318903960918604, 47.601781359829111 ], [ -122.318899748490111, 47.60141879584009 ], [ -122.320175333020188, 47.601142523840387 ], [ -122.320166265485881, 47.602205580016346 ], [ -122.320098711268869, 47.602284518063151 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320098711268869, 47.602284518063151 ], [ -122.320096435142148, 47.602841465585605 ], [ -122.320089344854111, 47.602846959015977 ], [ -122.319270167039917, 47.602853177197375 ], [ -122.319317889035275, 47.602165546628157 ], [ -122.320098711268869, 47.602284518063151 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.319270167039917, 47.602853177197375 ], [ -122.318991659870932, 47.60310131431573 ], [ -122.318986913660325, 47.602156818401923 ], [ -122.319049024523892, 47.602046610184679 ], [ -122.319317889035275, 47.602165546628157 ], [ -122.319270167039917, 47.602853177197375 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.26666666666666666 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.318673755324909, 47.603681220491957 ], [ -122.318171778504848, 47.603852491568844 ], [ -122.318133550611535, 47.60300173671223 ], [ -122.318986913660325, 47.602156818401923 ], [ -122.318991659870932, 47.60310131431573 ], [ -122.318673755324909, 47.603681220491957 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.047619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.319049024523892, 47.602046610184679 ], [ -122.318986913660325, 47.602156818401923 ], [ -122.318133550611535, 47.60300173671223 ], [ -122.318101609286586, 47.602290888297858 ], [ -122.318457292008461, 47.601955830504075 ], [ -122.318903960918604, 47.601781359829111 ], [ -122.319049024523892, 47.602046610184679 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.19047619047619047 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.318899748490111, 47.60141879584009 ], [ -122.318903960918604, 47.601781359829111 ], [ -122.318457292008461, 47.601955830504075 ], [ -122.31807830514056, 47.601772258739956 ], [ -122.3180691, 47.6015674 ], [ -122.318170574429232, 47.600354183662319 ], [ -122.318899748490111, 47.60141879584009 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.318457292008461, 47.601955830504075 ], [ -122.318101609286586, 47.602290888297858 ], [ -122.31807830514056, 47.601772258739956 ], [ -122.318457292008461, 47.601955830504075 ] ] ] } } +] +} diff --git a/tests/xnqm/outputs/p13_scores_polygon.geojson b/tests/xnqm/outputs/p13_scores_polygon.geojson new file mode 100644 index 0000000..8ed8ddd --- /dev/null +++ b/tests/xnqm/outputs/p13_scores_polygon.geojson @@ -0,0 +1,542 @@ +{ +"type": "FeatureCollection", +"crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:OGC:1.3:CRS84" } }, +"features": [ +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331255, 47.600404 ], [ -122.331257, 47.599964 ], [ -122.331915, 47.599956 ], [ -122.331913, 47.600464 ], [ -122.331905, 47.600471 ], [ -122.33138, 47.600462 ], [ -122.331255, 47.600404 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321965, 47.604448 ], [ -122.322394, 47.604057 ], [ -122.322743, 47.604889 ], [ -122.322573, 47.605046 ], [ -122.322231, 47.605085 ], [ -122.321965, 47.604448 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324276, 47.606327 ], [ -122.324448, 47.606327 ], [ -122.324736, 47.606998 ], [ -122.32451, 47.607201 ], [ -122.324186, 47.60723 ], [ -122.323926, 47.60659 ], [ -122.324152, 47.606388 ], [ -122.324276, 47.606327 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319322, 47.599652 ], [ -122.320023, 47.598768 ], [ -122.320332, 47.598766 ], [ -122.320331, 47.599883 ], [ -122.320097, 47.600019 ], [ -122.319614, 47.599806 ], [ -122.319322, 47.599652 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328289, 47.604798 ], [ -122.328502, 47.605298 ], [ -122.328499, 47.605552 ], [ -122.328007, 47.605642 ], [ -122.32761, 47.604708 ], [ -122.327634, 47.604659 ], [ -122.327723, 47.604658 ], [ -122.328289, 47.604798 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32765, 47.609029 ], [ -122.327945, 47.609731 ], [ -122.327279, 47.609686 ], [ -122.327033, 47.609098 ], [ -122.327194, 47.608954 ], [ -122.32765, 47.609029 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.38095238095238093 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323788, 47.606061 ], [ -122.32366, 47.605752 ], [ -122.323777, 47.605482 ], [ -122.323852, 47.605455 ], [ -122.32403, 47.605882 ], [ -122.323828, 47.606066 ], [ -122.323788, 47.606061 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335268, 47.600763 ], [ -122.335135, 47.600471 ], [ -122.335186, 47.600383 ], [ -122.335789, 47.600403 ], [ -122.335961, 47.60058 ], [ -122.335818, 47.600689 ], [ -122.335268, 47.600763 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323365, 47.602292 ], [ -122.323391, 47.602347 ], [ -122.323293, 47.602724 ], [ -122.322625, 47.602926 ], [ -122.322102, 47.602315 ], [ -122.323365, 47.602292 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3298, 47.607941 ], [ -122.329457, 47.607978 ], [ -122.329261, 47.607503 ], [ -122.329951, 47.606903 ], [ -122.32999, 47.606922 ], [ -122.330246, 47.607529 ], [ -122.3298, 47.607941 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33087, 47.601306 ], [ -122.330873, 47.600639 ], [ -122.331042, 47.600592 ], [ -122.331052, 47.601204 ], [ -122.331007, 47.601305 ], [ -122.330876, 47.601307 ], [ -122.33087, 47.601306 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327553, 47.608461 ], [ -122.327335, 47.607945 ], [ -122.327615, 47.607819 ], [ -122.327918, 47.608539 ], [ -122.327553, 47.608461 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.19444444444444445 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32999, 47.606922 ], [ -122.329951, 47.606903 ], [ -122.329523, 47.606515 ], [ -122.329444, 47.606333 ], [ -122.329755, 47.605926 ], [ -122.330074, 47.605796 ], [ -122.330222, 47.605762 ], [ -122.330553, 47.606555 ], [ -122.32999, 47.606922 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334462, 47.603975 ], [ -122.334762, 47.603934 ], [ -122.334998, 47.604124 ], [ -122.334291, 47.604773 ], [ -122.3341, 47.604308 ], [ -122.334462, 47.603975 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327865, 47.596025 ], [ -122.327877, 47.596006 ], [ -122.328695, 47.596009 ], [ -122.328329, 47.596827 ], [ -122.328243, 47.596898 ], [ -122.328153, 47.596872 ], [ -122.327865, 47.596025 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329958, 47.600579 ], [ -122.33046, 47.600582 ], [ -122.330561, 47.600687 ], [ -122.330558, 47.601056 ], [ -122.329961, 47.601049 ], [ -122.329958, 47.600579 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336335, 47.603349 ], [ -122.336615, 47.604014 ], [ -122.336397, 47.604212 ], [ -122.336066, 47.604225 ], [ -122.335753, 47.6035 ], [ -122.335893, 47.603371 ], [ -122.336335, 47.603349 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32088, 47.603878 ], [ -122.32049, 47.603883 ], [ -122.320499, 47.603202 ], [ -122.321435, 47.603192 ], [ -122.321266, 47.603649 ], [ -122.32088, 47.603878 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.41666666666666669 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336067, 47.605351 ], [ -122.336238, 47.605397 ], [ -122.336455, 47.605913 ], [ -122.336048, 47.606287 ], [ -122.335642, 47.606375 ], [ -122.335337, 47.606344 ], [ -122.335174, 47.605956 ], [ -122.335781, 47.605399 ], [ -122.336067, 47.605351 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331007, 47.601305 ], [ -122.331058, 47.601343 ], [ -122.331056, 47.601971 ], [ -122.330872, 47.601911 ], [ -122.330876, 47.601307 ], [ -122.331007, 47.601305 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321497, 47.599861 ], [ -122.321503, 47.598907 ], [ -122.321924, 47.59865 ], [ -122.322133, 47.598929 ], [ -122.322207, 47.599105 ], [ -122.322196, 47.600077 ], [ -122.321497, 47.599861 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329128, 47.609336 ], [ -122.329568, 47.608923 ], [ -122.329926, 47.608877 ], [ -122.330159, 47.609457 ], [ -122.329667, 47.60977 ], [ -122.329319, 47.609793 ], [ -122.329128, 47.609336 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1388888888888889 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333776, 47.603254 ], [ -122.333456, 47.60291 ], [ -122.333293, 47.602536 ], [ -122.333572, 47.602272 ], [ -122.333712, 47.602254 ], [ -122.333904, 47.602401 ], [ -122.334172, 47.603035 ], [ -122.333936, 47.603241 ], [ -122.333776, 47.603254 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.19444444444444445 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321826, 47.606435 ], [ -122.32184, 47.606404 ], [ -122.3223, 47.606352 ], [ -122.322519, 47.606886 ], [ -122.322429, 47.607184 ], [ -122.322172, 47.607145 ], [ -122.321832, 47.606782 ], [ -122.321812, 47.606736 ], [ -122.321826, 47.606435 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324733, 47.597097 ], [ -122.324736, 47.597095 ], [ -122.325383, 47.597099 ], [ -122.325381, 47.597943 ], [ -122.325378, 47.597945 ], [ -122.324878, 47.597942 ], [ -122.324731, 47.597725 ], [ -122.324733, 47.597097 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322444, 47.603916 ], [ -122.322394, 47.604057 ], [ -122.321965, 47.604448 ], [ -122.321527, 47.604415 ], [ -122.321506, 47.604203 ], [ -122.322225, 47.603593 ], [ -122.322444, 47.603916 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332878, 47.606573 ], [ -122.333271, 47.606874 ], [ -122.333445, 47.607287 ], [ -122.333232, 47.607483 ], [ -122.333113, 47.607424 ], [ -122.332764, 47.606584 ], [ -122.332878, 47.606573 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.083333333333333329 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320323, 47.606633 ], [ -122.320286, 47.606677 ], [ -122.320185, 47.606594 ], [ -122.319746, 47.606041 ], [ -122.319747, 47.605714 ], [ -122.320301, 47.605711 ], [ -122.320435, 47.606085 ], [ -122.320436, 47.606314 ], [ -122.320323, 47.606633 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326833, 47.595728 ], [ -122.326906, 47.595565 ], [ -122.327016, 47.595536 ], [ -122.327222, 47.595764 ], [ -122.326853, 47.595763 ], [ -122.326833, 47.595728 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329926, 47.608877 ], [ -122.329568, 47.608923 ], [ -122.329249, 47.608168 ], [ -122.329457, 47.607978 ], [ -122.3298, 47.607941 ], [ -122.330118, 47.608695 ], [ -122.329926, 47.608877 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335779, 47.600168 ], [ -122.335789, 47.600403 ], [ -122.335186, 47.600383 ], [ -122.335251, 47.600143 ], [ -122.335779, 47.600168 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.46666666666666667 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327865, 47.596025 ], [ -122.328153, 47.596872 ], [ -122.327649, 47.596869 ], [ -122.32734, 47.596098 ], [ -122.327382, 47.595985 ], [ -122.327865, 47.596025 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333651, 47.604276 ], [ -122.333637, 47.604055 ], [ -122.334094, 47.603636 ], [ -122.334462, 47.603975 ], [ -122.3341, 47.604308 ], [ -122.333651, 47.604276 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337014, 47.602048 ], [ -122.33679, 47.600854 ], [ -122.336971, 47.600543 ], [ -122.336975, 47.600539 ], [ -122.33742, 47.600437 ], [ -122.337423, 47.601725 ], [ -122.337054, 47.602061 ], [ -122.337014, 47.602048 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332114, 47.606935 ], [ -122.332396, 47.607607 ], [ -122.332355, 47.607797 ], [ -122.332177, 47.6079 ], [ -122.331811, 47.607031 ], [ -122.332114, 47.606935 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322855, 47.60649 ], [ -122.322519, 47.606886 ], [ -122.3223, 47.606352 ], [ -122.322657, 47.606026 ], [ -122.322855, 47.60649 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330883, 47.608408 ], [ -122.330321, 47.608669 ], [ -122.330118, 47.608695 ], [ -122.3298, 47.607941 ], [ -122.330246, 47.607529 ], [ -122.330594, 47.607661 ], [ -122.330892, 47.608383 ], [ -122.330883, 47.608408 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322018, 47.601945 ], [ -122.322015, 47.601366 ], [ -122.322796, 47.60063 ], [ -122.323261, 47.600975 ], [ -122.323256, 47.601947 ], [ -122.322018, 47.601945 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326696, 47.599897 ], [ -122.326694, 47.600458 ], [ -122.326031, 47.600458 ], [ -122.326033, 47.599613 ], [ -122.326037, 47.599611 ], [ -122.326584, 47.599614 ], [ -122.326696, 47.599897 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331823, 47.609222 ], [ -122.331899, 47.60887 ], [ -122.332335, 47.608477 ], [ -122.332694, 47.608601 ], [ -122.332099, 47.609138 ], [ -122.331823, 47.609222 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332489, 47.601872 ], [ -122.332306, 47.601856 ], [ -122.332099, 47.601827 ], [ -122.332101, 47.601305 ], [ -122.332544, 47.601315 ], [ -122.332544, 47.601853 ], [ -122.332489, 47.601872 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329067, 47.602049 ], [ -122.328883, 47.602181 ], [ -122.328583, 47.601635 ], [ -122.329022, 47.601631 ], [ -122.329067, 47.602049 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33513, 47.596938 ], [ -122.335465, 47.596795 ], [ -122.336679, 47.597467 ], [ -122.336707, 47.59749 ], [ -122.335022, 47.597128 ], [ -122.33513, 47.596938 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323565, 47.596417 ], [ -122.324089, 47.596228 ], [ -122.324086, 47.597093 ], [ -122.324083, 47.597095 ], [ -122.323563, 47.597092 ], [ -122.323565, 47.596417 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334513, 47.598935 ], [ -122.334555, 47.599044 ], [ -122.334554, 47.599327 ], [ -122.334187, 47.599325 ], [ -122.33419, 47.599116 ], [ -122.334513, 47.598935 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332436, 47.605935 ], [ -122.332787, 47.605623 ], [ -122.333051, 47.605595 ], [ -122.33336, 47.605592 ], [ -122.333517, 47.605975 ], [ -122.332878, 47.606573 ], [ -122.332764, 47.606584 ], [ -122.332708, 47.606584 ], [ -122.332436, 47.605935 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332694, 47.608601 ], [ -122.332773, 47.608613 ], [ -122.332759, 47.608844 ], [ -122.332475, 47.6091 ], [ -122.332099, 47.609138 ], [ -122.332694, 47.608601 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326039, 47.598783 ], [ -122.325375, 47.598778 ], [ -122.325378, 47.597945 ], [ -122.325381, 47.597943 ], [ -122.326045, 47.597947 ], [ -122.326042, 47.59878 ], [ -122.326039, 47.598783 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326852, 47.595896 ], [ -122.326853, 47.595763 ], [ -122.327222, 47.595764 ], [ -122.327364, 47.59584 ], [ -122.327366, 47.595897 ], [ -122.326852, 47.595896 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32356, 47.607202 ], [ -122.323296, 47.607443 ], [ -122.323104, 47.606971 ], [ -122.32336, 47.606736 ], [ -122.32356, 47.607202 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332525, 47.605211 ], [ -122.332008, 47.605668 ], [ -122.331924, 47.60547 ], [ -122.332431, 47.604983 ], [ -122.332525, 47.605211 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334195, 47.598534 ], [ -122.334196, 47.598136 ], [ -122.334584, 47.597988 ], [ -122.334578, 47.598642 ], [ -122.334575, 47.598646 ], [ -122.334195, 47.598534 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320097, 47.600019 ], [ -122.319967, 47.600328 ], [ -122.318774, 47.600747 ], [ -122.318939, 47.600381 ], [ -122.319614, 47.599806 ], [ -122.320097, 47.600019 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328099, 47.606475 ], [ -122.327768, 47.606775 ], [ -122.327606, 47.606793 ], [ -122.327289, 47.606031 ], [ -122.327506, 47.605839 ], [ -122.327818, 47.605802 ], [ -122.328099, 47.606475 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331385, 47.607255 ], [ -122.331007, 47.606354 ], [ -122.331042, 47.606321 ], [ -122.331084, 47.606318 ], [ -122.331505, 47.606585 ], [ -122.331695, 47.60704 ], [ -122.331455, 47.607249 ], [ -122.331385, 47.607255 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318992, 47.603175 ], [ -122.318509, 47.603468 ], [ -122.318402, 47.602736 ], [ -122.318987, 47.602157 ], [ -122.318992, 47.603175 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331961, 47.599779 ], [ -122.331915, 47.599956 ], [ -122.331257, 47.599964 ], [ -122.33121, 47.599789 ], [ -122.331961, 47.599779 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330321, 47.608669 ], [ -122.330585, 47.609324 ], [ -122.330343, 47.609531 ], [ -122.330159, 47.609457 ], [ -122.329926, 47.608877 ], [ -122.330118, 47.608695 ], [ -122.330321, 47.608669 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333293, 47.602536 ], [ -122.333456, 47.60291 ], [ -122.332981, 47.603346 ], [ -122.332798, 47.6029 ], [ -122.333189, 47.602548 ], [ -122.333293, 47.602536 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.066666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330608, 47.598969 ], [ -122.330725, 47.598758 ], [ -122.331059, 47.598606 ], [ -122.331255, 47.598748 ], [ -122.331253, 47.599457 ], [ -122.331123, 47.599628 ], [ -122.330697, 47.599625 ], [ -122.330609, 47.599538 ], [ -122.330606, 47.599534 ], [ -122.330608, 47.598969 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.53333333333333333 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321016, 47.607277 ], [ -122.320286, 47.606677 ], [ -122.320323, 47.606633 ], [ -122.32094, 47.606639 ], [ -122.321072, 47.607024 ], [ -122.321016, 47.607277 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324722, 47.598779 ], [ -122.324096, 47.598775 ], [ -122.324075, 47.598756 ], [ -122.324077, 47.598143 ], [ -122.324727, 47.598159 ], [ -122.324725, 47.598777 ], [ -122.324722, 47.598779 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326027, 47.609106 ], [ -122.326488, 47.609317 ], [ -122.326484, 47.609343 ], [ -122.326289, 47.609521 ], [ -122.325699, 47.609401 ], [ -122.326027, 47.609106 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326708, 47.601318 ], [ -122.326691, 47.601304 ], [ -122.326697, 47.60046 ], [ -122.327254, 47.600463 ], [ -122.327344, 47.600804 ], [ -122.327352, 47.601287 ], [ -122.326708, 47.601318 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336702, 47.604001 ], [ -122.336615, 47.604014 ], [ -122.336335, 47.603349 ], [ -122.336709, 47.602998 ], [ -122.336985, 47.603046 ], [ -122.337197, 47.603551 ], [ -122.336702, 47.604001 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322779, 47.597937 ], [ -122.321952, 47.597932 ], [ -122.321546, 47.597453 ], [ -122.322543, 47.596901 ], [ -122.322782, 47.597089 ], [ -122.322779, 47.597937 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329079, 47.604134 ], [ -122.328823, 47.603514 ], [ -122.329134, 47.603231 ], [ -122.329515, 47.603187 ], [ -122.329754, 47.6035 ], [ -122.329079, 47.604134 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329921, 47.599885 ], [ -122.330322, 47.599517 ], [ -122.330606, 47.599534 ], [ -122.330609, 47.599538 ], [ -122.330158, 47.599936 ], [ -122.329956, 47.599982 ], [ -122.329921, 47.599885 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328425, 47.600985 ], [ -122.328433, 47.600456 ], [ -122.328637, 47.600404 ], [ -122.328774, 47.600799 ], [ -122.328772, 47.60098 ], [ -122.328425, 47.600985 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322779, 47.598608 ], [ -122.32195, 47.598598 ], [ -122.321952, 47.597932 ], [ -122.322779, 47.597937 ], [ -122.322781, 47.597939 ], [ -122.322779, 47.598608 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325372, 47.598781 ], [ -122.32537, 47.599443 ], [ -122.32472, 47.599439 ], [ -122.324722, 47.598779 ], [ -122.324725, 47.598777 ], [ -122.325372, 47.598781 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33027, 47.60242 ], [ -122.330236, 47.602333 ], [ -122.330551, 47.601884 ], [ -122.330872, 47.601911 ], [ -122.331056, 47.601971 ], [ -122.331308, 47.602249 ], [ -122.330749, 47.602757 ], [ -122.330657, 47.602716 ], [ -122.33027, 47.60242 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1111111111111111 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328559, 47.599643 ], [ -122.32822, 47.599598 ], [ -122.328223, 47.598692 ], [ -122.328287, 47.598579 ], [ -122.328358, 47.598514 ], [ -122.328513, 47.598641 ], [ -122.328728, 47.599035 ], [ -122.328727, 47.599229 ], [ -122.328705, 47.599457 ], [ -122.328559, 47.599643 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328695, 47.596009 ], [ -122.327877, 47.596006 ], [ -122.328079, 47.595418 ], [ -122.329076, 47.595352 ], [ -122.328695, 47.596009 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324186, 47.60723 ], [ -122.32451, 47.607201 ], [ -122.324886, 47.608104 ], [ -122.324799, 47.608114 ], [ -122.324231, 47.608012 ], [ -122.323999, 47.607452 ], [ -122.324014, 47.607376 ], [ -122.324186, 47.60723 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335791, 47.600154 ], [ -122.335779, 47.600168 ], [ -122.335251, 47.600143 ], [ -122.335249, 47.59965 ], [ -122.335273, 47.599627 ], [ -122.335452, 47.59963 ], [ -122.335789, 47.599916 ], [ -122.335791, 47.600154 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323563, 47.597092 ], [ -122.324083, 47.597095 ], [ -122.324081, 47.597732 ], [ -122.323952, 47.59794 ], [ -122.323428, 47.597937 ], [ -122.323426, 47.597936 ], [ -122.323429, 47.59715 ], [ -122.323563, 47.597092 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331056, 47.601971 ], [ -122.331058, 47.601343 ], [ -122.331587, 47.601506 ], [ -122.331585, 47.60213 ], [ -122.331502, 47.602207 ], [ -122.331308, 47.602249 ], [ -122.331056, 47.601971 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329895, 47.597686 ], [ -122.32836, 47.597705 ], [ -122.328358, 47.597347 ], [ -122.330067, 47.597358 ], [ -122.329895, 47.597686 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33384, 47.598536 ], [ -122.333841, 47.598535 ], [ -122.334195, 47.598534 ], [ -122.334575, 47.598646 ], [ -122.33451, 47.598884 ], [ -122.333841, 47.598887 ], [ -122.33384, 47.598536 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336455, 47.605913 ], [ -122.336874, 47.606075 ], [ -122.336969, 47.606303 ], [ -122.336307, 47.606911 ], [ -122.336048, 47.606287 ], [ -122.336455, 47.605913 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33419, 47.599116 ], [ -122.334187, 47.599325 ], [ -122.33398, 47.599435 ], [ -122.33396, 47.599116 ], [ -122.33419, 47.599116 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326569, 47.603794 ], [ -122.326372, 47.603792 ], [ -122.325985, 47.60332 ], [ -122.327287, 47.602417 ], [ -122.327618, 47.602835 ], [ -122.326569, 47.603794 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336755, 47.597529 ], [ -122.336803, 47.597569 ], [ -122.336301, 47.597757 ], [ -122.335112, 47.597829 ], [ -122.334956, 47.597652 ], [ -122.336755, 47.597529 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.066666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337788, 47.60184 ], [ -122.337785, 47.60027 ], [ -122.33841, 47.599913 ], [ -122.338408, 47.601737 ], [ -122.338226, 47.602022 ], [ -122.337788, 47.60184 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331587, 47.601506 ], [ -122.331827, 47.601279 ], [ -122.331901, 47.601243 ], [ -122.332101, 47.601305 ], [ -122.332099, 47.601827 ], [ -122.331775, 47.602133 ], [ -122.331585, 47.60213 ], [ -122.331587, 47.601506 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325497, 47.60087 ], [ -122.325363, 47.60087 ], [ -122.325366, 47.599935 ], [ -122.325413, 47.599768 ], [ -122.325492, 47.59961 ], [ -122.326033, 47.599613 ], [ -122.326031, 47.600458 ], [ -122.325497, 47.60087 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.41666666666666669 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326934, 47.608154 ], [ -122.326487, 47.608208 ], [ -122.326255, 47.60817 ], [ -122.326043, 47.607664 ], [ -122.326339, 47.607392 ], [ -122.32681, 47.607123 ], [ -122.326813, 47.607124 ], [ -122.327151, 47.607958 ], [ -122.326934, 47.608154 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337725, 47.603097 ], [ -122.337226, 47.603563 ], [ -122.337197, 47.603551 ], [ -122.336985, 47.603046 ], [ -122.337462, 47.60261 ], [ -122.337538, 47.602622 ], [ -122.337725, 47.603097 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331075, 47.607319 ], [ -122.330748, 47.606538 ], [ -122.331007, 47.606354 ], [ -122.331385, 47.607255 ], [ -122.331102, 47.607317 ], [ -122.331075, 47.607319 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320435, 47.606085 ], [ -122.321118, 47.606079 ], [ -122.321106, 47.606346 ], [ -122.321092, 47.606357 ], [ -122.320436, 47.606314 ], [ -122.320435, 47.606085 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326906, 47.595565 ], [ -122.326864, 47.595519 ], [ -122.327008, 47.595489 ], [ -122.327041, 47.595487 ], [ -122.327016, 47.595536 ], [ -122.326906, 47.595565 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328637, 47.600404 ], [ -122.328668, 47.600373 ], [ -122.329067, 47.600376 ], [ -122.32937, 47.600426 ], [ -122.329211, 47.600798 ], [ -122.328774, 47.600799 ], [ -122.328637, 47.600404 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.083333333333333329 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3238, 47.608395 ], [ -122.32372, 47.60861 ], [ -122.323713, 47.608609 ], [ -122.323047, 47.608104 ], [ -122.322935, 47.607825 ], [ -122.322937, 47.607785 ], [ -122.323081, 47.607732 ], [ -122.323551, 47.6078 ], [ -122.3238, 47.608395 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1388888888888889 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33396, 47.599116 ], [ -122.33398, 47.599435 ], [ -122.333872, 47.599686 ], [ -122.333839, 47.599699 ], [ -122.333699, 47.599654 ], [ -122.333673, 47.599212 ], [ -122.333748, 47.598961 ], [ -122.333826, 47.598921 ], [ -122.33396, 47.599116 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.054545454545454543 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332335, 47.608477 ], [ -122.332119, 47.607964 ], [ -122.332121, 47.607952 ], [ -122.332177, 47.6079 ], [ -122.332355, 47.607797 ], [ -122.332758, 47.60792 ], [ -122.332986, 47.608459 ], [ -122.332937, 47.608502 ], [ -122.332773, 47.608613 ], [ -122.332694, 47.608601 ], [ -122.332335, 47.608477 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323104, 47.606971 ], [ -122.322554, 47.607303 ], [ -122.322429, 47.607184 ], [ -122.322519, 47.606886 ], [ -122.322855, 47.60649 ], [ -122.323374, 47.606657 ], [ -122.32336, 47.606736 ], [ -122.323104, 47.606971 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333346, 47.597269 ], [ -122.333077, 47.59709 ], [ -122.332906, 47.596937 ], [ -122.332895, 47.596885 ], [ -122.334485, 47.596569 ], [ -122.3349, 47.597224 ], [ -122.334781, 47.597438 ], [ -122.333346, 47.597269 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331179, 47.608284 ], [ -122.330892, 47.608383 ], [ -122.330594, 47.607661 ], [ -122.331075, 47.607319 ], [ -122.331102, 47.607317 ], [ -122.331369, 47.607982 ], [ -122.331179, 47.608284 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334183, 47.600473 ], [ -122.334184, 47.601142 ], [ -122.333834, 47.601141 ], [ -122.333833, 47.600474 ], [ -122.333837, 47.600471 ], [ -122.334183, 47.600473 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335174, 47.605956 ], [ -122.335337, 47.606344 ], [ -122.335285, 47.606439 ], [ -122.334885, 47.606796 ], [ -122.334554, 47.606823 ], [ -122.334245, 47.606087 ], [ -122.334468, 47.605878 ], [ -122.334973, 47.605829 ], [ -122.335174, 47.605956 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326065, 47.595682 ], [ -122.32649, 47.595595 ], [ -122.326548, 47.595674 ], [ -122.326547, 47.596011 ], [ -122.326064, 47.59601 ], [ -122.326065, 47.595682 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324727, 47.598159 ], [ -122.324878, 47.597942 ], [ -122.325378, 47.597945 ], [ -122.325375, 47.598778 ], [ -122.325372, 47.598781 ], [ -122.324725, 47.598777 ], [ -122.324727, 47.598159 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319371, 47.605568 ], [ -122.319194, 47.605345 ], [ -122.31894, 47.60478 ], [ -122.319373, 47.604791 ], [ -122.319371, 47.605568 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32346, 47.606354 ], [ -122.323333, 47.606052 ], [ -122.32366, 47.605752 ], [ -122.323788, 47.606061 ], [ -122.32346, 47.606354 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.066666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331179, 47.608284 ], [ -122.331337, 47.608306 ], [ -122.331682, 47.608373 ], [ -122.331899, 47.60887 ], [ -122.331823, 47.609222 ], [ -122.331618, 47.609537 ], [ -122.331232, 47.609205 ], [ -122.330883, 47.608408 ], [ -122.330892, 47.608383 ], [ -122.331179, 47.608284 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337251, 47.604723 ], [ -122.337028, 47.604917 ], [ -122.336698, 47.604934 ], [ -122.336397, 47.604212 ], [ -122.336615, 47.604014 ], [ -122.336702, 47.604001 ], [ -122.337078, 47.604301 ], [ -122.337251, 47.604723 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326037, 47.599611 ], [ -122.326033, 47.599613 ], [ -122.325492, 47.59961 ], [ -122.32537, 47.599443 ], [ -122.325372, 47.598781 ], [ -122.325375, 47.598778 ], [ -122.326039, 47.598783 ], [ -122.326037, 47.599611 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330135, 47.601472 ], [ -122.330555, 47.60147 ], [ -122.330551, 47.601884 ], [ -122.330236, 47.602333 ], [ -122.330135, 47.602255 ], [ -122.330135, 47.601472 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328728, 47.599035 ], [ -122.328513, 47.598641 ], [ -122.328975, 47.598663 ], [ -122.329275, 47.598961 ], [ -122.329099, 47.599043 ], [ -122.328728, 47.599035 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333372, 47.605567 ], [ -122.332982, 47.604615 ], [ -122.333157, 47.604452 ], [ -122.333498, 47.604413 ], [ -122.33381, 47.605175 ], [ -122.333372, 47.605567 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328499, 47.605552 ], [ -122.328582, 47.605614 ], [ -122.328782, 47.605836 ], [ -122.328913, 47.606135 ], [ -122.328529, 47.606475 ], [ -122.328099, 47.606475 ], [ -122.327818, 47.605802 ], [ -122.328007, 47.605642 ], [ -122.328499, 47.605552 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323293, 47.602724 ], [ -122.323391, 47.602347 ], [ -122.324867, 47.602201 ], [ -122.325104, 47.602526 ], [ -122.323689, 47.603663 ], [ -122.323293, 47.602724 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327553, 47.608461 ], [ -122.327918, 47.608539 ], [ -122.328066, 47.608643 ], [ -122.32765, 47.609029 ], [ -122.327194, 47.608954 ], [ -122.327198, 47.608787 ], [ -122.327553, 47.608461 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333015, 47.608457 ], [ -122.333331, 47.609211 ], [ -122.333247, 47.609241 ], [ -122.332937, 47.608502 ], [ -122.332986, 47.608459 ], [ -122.333015, 47.608457 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5357142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328194, 47.602661 ], [ -122.328447, 47.602527 ], [ -122.328665, 47.602495 ], [ -122.328826, 47.602873 ], [ -122.328128, 47.603499 ], [ -122.328098, 47.603486 ], [ -122.327886, 47.602944 ], [ -122.328194, 47.602661 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320771, 47.604408 ], [ -122.321021, 47.604405 ], [ -122.321266, 47.604585 ], [ -122.320921, 47.604903 ], [ -122.320429, 47.604902 ], [ -122.320359, 47.604821 ], [ -122.320771, 47.604408 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.39285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319252, 47.603109 ], [ -122.319705, 47.603144 ], [ -122.319718, 47.603931 ], [ -122.319381, 47.603955 ], [ -122.318577, 47.60394 ], [ -122.318509, 47.603468 ], [ -122.318992, 47.603175 ], [ -122.319252, 47.603109 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331042, 47.606321 ], [ -122.330809, 47.605761 ], [ -122.331236, 47.605375 ], [ -122.331485, 47.605956 ], [ -122.331084, 47.606318 ], [ -122.331042, 47.606321 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327634, 47.604659 ], [ -122.327398, 47.604102 ], [ -122.328098, 47.603486 ], [ -122.328128, 47.603499 ], [ -122.328155, 47.603515 ], [ -122.328385, 47.604072 ], [ -122.327723, 47.604658 ], [ -122.327634, 47.604659 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330748, 47.606538 ], [ -122.330553, 47.606555 ], [ -122.330222, 47.605762 ], [ -122.330356, 47.605646 ], [ -122.330809, 47.605761 ], [ -122.331042, 47.606321 ], [ -122.331007, 47.606354 ], [ -122.330748, 47.606538 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.38095238095238093 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327597, 47.599419 ], [ -122.327329, 47.599588 ], [ -122.327232, 47.599512 ], [ -122.327233, 47.599198 ], [ -122.327323, 47.598898 ], [ -122.327496, 47.598986 ], [ -122.327597, 47.599419 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32388, 47.60543 ], [ -122.32361, 47.604776 ], [ -122.32393, 47.604767 ], [ -122.32416, 47.605322 ], [ -122.32388, 47.60543 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335915, 47.602226 ], [ -122.336325, 47.602302 ], [ -122.336437, 47.602587 ], [ -122.335871, 47.603117 ], [ -122.335577, 47.602381 ], [ -122.335915, 47.602226 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321158, 47.601358 ], [ -122.320885, 47.60122 ], [ -122.320891, 47.600802 ], [ -122.321357, 47.600795 ], [ -122.321351, 47.601279 ], [ -122.321158, 47.601358 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319967, 47.600328 ], [ -122.319994, 47.600841 ], [ -122.318562, 47.601324 ], [ -122.318585, 47.601168 ], [ -122.318774, 47.600747 ], [ -122.319967, 47.600328 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323091, 47.59978 ], [ -122.323191, 47.599658 ], [ -122.323195, 47.599656 ], [ -122.324162, 47.599662 ], [ -122.324098, 47.599799 ], [ -122.323091, 47.59978 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328863, 47.607278 ], [ -122.328783, 47.60729 ], [ -122.32855, 47.606718 ], [ -122.328529, 47.606475 ], [ -122.328913, 47.606135 ], [ -122.329444, 47.606333 ], [ -122.329523, 47.606515 ], [ -122.328863, 47.607278 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329022, 47.601631 ], [ -122.328583, 47.601635 ], [ -122.328531, 47.601575 ], [ -122.32863, 47.60147 ], [ -122.329411, 47.601464 ], [ -122.329414, 47.601561 ], [ -122.329022, 47.601631 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330322, 47.599517 ], [ -122.329921, 47.599885 ], [ -122.329684, 47.599693 ], [ -122.330071, 47.599337 ], [ -122.330322, 47.599517 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5357142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336287, 47.607268 ], [ -122.336485, 47.607407 ], [ -122.336617, 47.607725 ], [ -122.335809, 47.608172 ], [ -122.335534, 47.607509 ], [ -122.335672, 47.607383 ], [ -122.336013, 47.607267 ], [ -122.336287, 47.607268 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1388888888888889 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321503, 47.598907 ], [ -122.320543, 47.598417 ], [ -122.320543, 47.598269 ], [ -122.321519, 47.597467 ], [ -122.321546, 47.597453 ], [ -122.321952, 47.597932 ], [ -122.32195, 47.598598 ], [ -122.321924, 47.59865 ], [ -122.321503, 47.598907 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331308, 47.602249 ], [ -122.331502, 47.602207 ], [ -122.331847, 47.603033 ], [ -122.331536, 47.603316 ], [ -122.331051, 47.603246 ], [ -122.330916, 47.60316 ], [ -122.330749, 47.602757 ], [ -122.331308, 47.602249 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.083333333333333329 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329769, 47.598208 ], [ -122.329763, 47.598149 ], [ -122.329895, 47.597686 ], [ -122.330067, 47.597358 ], [ -122.33033, 47.597007 ], [ -122.331062, 47.597819 ], [ -122.331059, 47.598606 ], [ -122.330725, 47.598758 ], [ -122.329769, 47.598208 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325431, 47.604774 ], [ -122.326226, 47.604395 ], [ -122.326533, 47.605129 ], [ -122.326098, 47.605523 ], [ -122.325775, 47.605582 ], [ -122.325431, 47.604774 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337892, 47.604385 ], [ -122.338284, 47.604451 ], [ -122.338542, 47.605104 ], [ -122.33822, 47.605394 ], [ -122.337894, 47.605432 ], [ -122.337577, 47.604678 ], [ -122.337892, 47.604385 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327506, 47.605839 ], [ -122.327289, 47.606031 ], [ -122.326949, 47.606064 ], [ -122.326558, 47.605139 ], [ -122.327184, 47.605077 ], [ -122.327506, 47.605839 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32393, 47.604767 ], [ -122.324492, 47.604251 ], [ -122.324715, 47.604413 ], [ -122.324858, 47.60473 ], [ -122.324813, 47.604856 ], [ -122.324316, 47.605308 ], [ -122.32416, 47.605322 ], [ -122.32393, 47.604767 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331682, 47.608373 ], [ -122.332119, 47.607964 ], [ -122.332335, 47.608477 ], [ -122.331899, 47.60887 ], [ -122.331682, 47.608373 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333005, 47.603551 ], [ -122.332837, 47.603709 ], [ -122.332495, 47.603745 ], [ -122.332191, 47.602994 ], [ -122.332351, 47.602846 ], [ -122.332798, 47.6029 ], [ -122.332981, 47.603346 ], [ -122.333005, 47.603551 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331232, 47.609205 ], [ -122.330585, 47.609324 ], [ -122.330321, 47.608669 ], [ -122.330883, 47.608408 ], [ -122.331232, 47.609205 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327649, 47.596869 ], [ -122.327322, 47.597024 ], [ -122.326994, 47.596215 ], [ -122.32734, 47.596098 ], [ -122.327649, 47.596869 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334178, 47.601565 ], [ -122.334178, 47.601936 ], [ -122.333861, 47.60202 ], [ -122.333863, 47.601562 ], [ -122.334178, 47.601565 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335781, 47.598918 ], [ -122.335337, 47.598945 ], [ -122.335201, 47.598641 ], [ -122.335273, 47.598473 ], [ -122.335675, 47.598456 ], [ -122.335942, 47.598851 ], [ -122.335781, 47.598918 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328385, 47.604072 ], [ -122.328744, 47.604392 ], [ -122.328289, 47.604798 ], [ -122.327723, 47.604658 ], [ -122.328385, 47.604072 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333429, 47.603573 ], [ -122.333776, 47.603254 ], [ -122.333936, 47.603241 ], [ -122.334094, 47.603636 ], [ -122.333637, 47.604055 ], [ -122.333429, 47.603573 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336452, 47.601165 ], [ -122.335813, 47.601105 ], [ -122.335818, 47.600689 ], [ -122.335961, 47.60058 ], [ -122.336971, 47.600543 ], [ -122.33679, 47.600854 ], [ -122.336472, 47.601157 ], [ -122.336452, 47.601165 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329723, 47.604941 ], [ -122.330074, 47.605796 ], [ -122.329755, 47.605926 ], [ -122.329471, 47.605233 ], [ -122.329508, 47.604887 ], [ -122.32955, 47.604888 ], [ -122.329723, 47.604941 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332749, 47.599208 ], [ -122.332746, 47.599792 ], [ -122.33238, 47.599628 ], [ -122.332444, 47.598979 ], [ -122.332566, 47.598889 ], [ -122.332674, 47.59895 ], [ -122.332749, 47.599208 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323047, 47.608104 ], [ -122.322949, 47.608376 ], [ -122.322876, 47.608441 ], [ -122.322495, 47.608231 ], [ -122.322935, 47.607825 ], [ -122.323047, 47.608104 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321367, 47.600759 ], [ -122.321357, 47.600795 ], [ -122.320891, 47.600802 ], [ -122.320794, 47.600009 ], [ -122.321167, 47.599969 ], [ -122.321367, 47.600759 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328723, 47.607346 ], [ -122.328783, 47.60729 ], [ -122.328863, 47.607278 ], [ -122.329261, 47.607503 ], [ -122.329457, 47.607978 ], [ -122.329249, 47.608168 ], [ -122.329081, 47.608188 ], [ -122.328723, 47.607346 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334291, 47.604773 ], [ -122.334316, 47.604984 ], [ -122.334152, 47.60514 ], [ -122.33381, 47.605175 ], [ -122.333498, 47.604413 ], [ -122.333651, 47.604276 ], [ -122.3341, 47.604308 ], [ -122.334291, 47.604773 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.26666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332551, 47.60131 ], [ -122.332555, 47.600471 ], [ -122.332895, 47.600221 ], [ -122.333203, 47.60047 ], [ -122.3332, 47.60131 ], [ -122.332551, 47.60131 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330916, 47.60316 ], [ -122.331051, 47.603246 ], [ -122.331026, 47.603702 ], [ -122.330603, 47.604085 ], [ -122.330287, 47.60373 ], [ -122.330916, 47.60316 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334973, 47.605829 ], [ -122.334468, 47.605878 ], [ -122.334152, 47.60514 ], [ -122.334316, 47.604984 ], [ -122.334745, 47.605 ], [ -122.334957, 47.605496 ], [ -122.334973, 47.605829 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327194, 47.608954 ], [ -122.327033, 47.609098 ], [ -122.326853, 47.609115 ], [ -122.326487, 47.608208 ], [ -122.326934, 47.608154 ], [ -122.327198, 47.608787 ], [ -122.327194, 47.608954 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1111111111111111 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323476, 47.606559 ], [ -122.323374, 47.606657 ], [ -122.322855, 47.60649 ], [ -122.322657, 47.606026 ], [ -122.322663, 47.605992 ], [ -122.322886, 47.605796 ], [ -122.322904, 47.605795 ], [ -122.323333, 47.606052 ], [ -122.32346, 47.606354 ], [ -122.323476, 47.606559 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.13333333333333333 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325543, 47.602786 ], [ -122.325423, 47.60274 ], [ -122.325104, 47.602526 ], [ -122.324867, 47.602201 ], [ -122.32487, 47.601069 ], [ -122.325363, 47.60087 ], [ -122.325497, 47.60087 ], [ -122.32603, 47.601294 ], [ -122.326028, 47.601975 ], [ -122.325543, 47.602786 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334361, 47.607001 ], [ -122.334554, 47.606823 ], [ -122.334885, 47.606796 ], [ -122.335201, 47.607537 ], [ -122.334985, 47.607727 ], [ -122.334687, 47.607767 ], [ -122.334361, 47.607001 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332982, 47.604615 ], [ -122.333372, 47.605567 ], [ -122.33336, 47.605592 ], [ -122.333051, 47.605595 ], [ -122.332676, 47.604678 ], [ -122.332982, 47.604615 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326708, 47.597949 ], [ -122.327032, 47.597696 ], [ -122.327361, 47.597949 ], [ -122.32736, 47.598572 ], [ -122.327243, 47.598756 ], [ -122.326705, 47.598753 ], [ -122.326708, 47.597949 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325673, 47.602907 ], [ -122.325543, 47.602786 ], [ -122.326028, 47.601975 ], [ -122.326707, 47.601873 ], [ -122.32685, 47.602095 ], [ -122.325673, 47.602907 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326045, 47.597947 ], [ -122.326048, 47.597945 ], [ -122.326708, 47.597949 ], [ -122.326705, 47.598753 ], [ -122.326668, 47.598784 ], [ -122.326042, 47.59878 ], [ -122.326045, 47.597947 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7142857142857143 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322886, 47.605796 ], [ -122.322573, 47.605046 ], [ -122.322743, 47.604889 ], [ -122.323117, 47.604808 ], [ -122.323356, 47.605382 ], [ -122.322904, 47.605795 ], [ -122.322886, 47.605796 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.338205, 47.602402 ], [ -122.338615, 47.6027 ], [ -122.338629, 47.602731 ], [ -122.338653, 47.603405 ], [ -122.338144, 47.603437 ], [ -122.337894, 47.602541 ], [ -122.338205, 47.602402 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326579, 47.596311 ], [ -122.326718, 47.596173 ], [ -122.326754, 47.596172 ], [ -122.326847, 47.596221 ], [ -122.326909, 47.597131 ], [ -122.326826, 47.597104 ], [ -122.326547, 47.596589 ], [ -122.326551, 47.596459 ], [ -122.326579, 47.596311 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331915, 47.598523 ], [ -122.33175, 47.598762 ], [ -122.331255, 47.598748 ], [ -122.331059, 47.598606 ], [ -122.331062, 47.597819 ], [ -122.331917, 47.59782 ], [ -122.331915, 47.598523 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1388888888888889 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323548, 47.598753 ], [ -122.323544, 47.599197 ], [ -122.32349, 47.599385 ], [ -122.32331, 47.599563 ], [ -122.323195, 47.599656 ], [ -122.323191, 47.599658 ], [ -122.3232, 47.598762 ], [ -122.323426, 47.598692 ], [ -122.323548, 47.598753 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323548, 47.598753 ], [ -122.323426, 47.598692 ], [ -122.323428, 47.597937 ], [ -122.323952, 47.59794 ], [ -122.324077, 47.598143 ], [ -122.324075, 47.598756 ], [ -122.323548, 47.598753 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326098, 47.605523 ], [ -122.326459, 47.606377 ], [ -122.32597, 47.606505 ], [ -122.325868, 47.606509 ], [ -122.325559, 47.60578 ], [ -122.325775, 47.605582 ], [ -122.326098, 47.605523 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318939, 47.600381 ], [ -122.319195, 47.599812 ], [ -122.319322, 47.599652 ], [ -122.319614, 47.599806 ], [ -122.318939, 47.600381 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7142857142857143 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333586, 47.607276 ], [ -122.333445, 47.607287 ], [ -122.333271, 47.606874 ], [ -122.333741, 47.606436 ], [ -122.334005, 47.607064 ], [ -122.333885, 47.607175 ], [ -122.333586, 47.607276 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321167, 47.599969 ], [ -122.320794, 47.600009 ], [ -122.320331, 47.599883 ], [ -122.320332, 47.598766 ], [ -122.320543, 47.598417 ], [ -122.321503, 47.598907 ], [ -122.321497, 47.599861 ], [ -122.321167, 47.599969 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32537, 47.599443 ], [ -122.325492, 47.59961 ], [ -122.325413, 47.599768 ], [ -122.324666, 47.599763 ], [ -122.324584, 47.599608 ], [ -122.32472, 47.599439 ], [ -122.32537, 47.599443 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32736, 47.598572 ], [ -122.327361, 47.597949 ], [ -122.328296, 47.597955 ], [ -122.328377, 47.598176 ], [ -122.328358, 47.598514 ], [ -122.328287, 47.598579 ], [ -122.32736, 47.598572 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334069, 47.607056 ], [ -122.334361, 47.607001 ], [ -122.334687, 47.607767 ], [ -122.334458, 47.607956 ], [ -122.334069, 47.607056 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.52380952380952384 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330685, 47.59967 ], [ -122.330684, 47.600154 ], [ -122.330543, 47.600281 ], [ -122.330359, 47.600161 ], [ -122.330359, 47.600022 ], [ -122.33038, 47.599938 ], [ -122.330685, 47.59967 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325021, 47.608332 ], [ -122.325242, 47.608646 ], [ -122.325133, 47.608877 ], [ -122.324789, 47.609182 ], [ -122.324273, 47.608996 ], [ -122.325021, 47.608332 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322132, 47.603374 ], [ -122.322225, 47.603593 ], [ -122.321506, 47.604203 ], [ -122.321266, 47.603649 ], [ -122.321435, 47.603192 ], [ -122.321496, 47.603135 ], [ -122.322132, 47.603374 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333839, 47.599699 ], [ -122.333872, 47.599686 ], [ -122.334193, 47.599743 ], [ -122.334186, 47.600473 ], [ -122.334183, 47.600473 ], [ -122.333837, 47.600471 ], [ -122.333839, 47.599699 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328582, 47.605614 ], [ -122.328499, 47.605552 ], [ -122.328502, 47.605298 ], [ -122.329266, 47.604615 ], [ -122.329267, 47.604616 ], [ -122.329459, 47.604846 ], [ -122.328582, 47.605614 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.066666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329425, 47.599547 ], [ -122.329444, 47.599575 ], [ -122.329463, 47.599628 ], [ -122.329379, 47.599764 ], [ -122.329222, 47.599807 ], [ -122.328645, 47.599803 ], [ -122.328559, 47.599643 ], [ -122.328705, 47.599457 ], [ -122.329179, 47.59946 ], [ -122.329425, 47.599547 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335715, 47.598099 ], [ -122.336301, 47.597757 ], [ -122.336803, 47.597569 ], [ -122.337277, 47.597958 ], [ -122.336743, 47.59832 ], [ -122.335744, 47.598382 ], [ -122.335715, 47.598099 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.339627, 47.603903 ], [ -122.339614, 47.603989 ], [ -122.339196, 47.604917 ], [ -122.338917, 47.60517 ], [ -122.338542, 47.605104 ], [ -122.338284, 47.604451 ], [ -122.33902, 47.603784 ], [ -122.339627, 47.603903 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.083333333333333329 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334538, 47.601219 ], [ -122.334537, 47.600476 ], [ -122.334542, 47.600473 ], [ -122.335135, 47.600471 ], [ -122.335268, 47.600763 ], [ -122.335266, 47.601252 ], [ -122.3352, 47.601307 ], [ -122.334608, 47.601319 ], [ -122.334538, 47.601219 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321458, 47.602777 ], [ -122.320419, 47.602788 ], [ -122.320422, 47.602204 ], [ -122.321151, 47.602199 ], [ -122.321459, 47.602437 ], [ -122.321458, 47.602777 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333222, 47.599201 ], [ -122.333673, 47.599212 ], [ -122.333699, 47.599654 ], [ -122.333219, 47.59965 ], [ -122.33322, 47.599211 ], [ -122.333222, 47.599201 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329261, 47.607503 ], [ -122.328863, 47.607278 ], [ -122.329523, 47.606515 ], [ -122.329951, 47.606903 ], [ -122.329261, 47.607503 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332155, 47.598979 ], [ -122.332153, 47.599632 ], [ -122.332023, 47.599659 ], [ -122.331822, 47.59945 ], [ -122.331824, 47.598867 ], [ -122.332155, 47.598979 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328098, 47.603486 ], [ -122.327398, 47.604102 ], [ -122.326569, 47.603794 ], [ -122.327618, 47.602835 ], [ -122.327886, 47.602944 ], [ -122.328098, 47.603486 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333697, 47.601304 ], [ -122.333863, 47.601562 ], [ -122.333861, 47.60202 ], [ -122.333712, 47.602254 ], [ -122.333572, 47.602272 ], [ -122.333563, 47.602259 ], [ -122.333566, 47.601313 ], [ -122.333697, 47.601304 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321151, 47.602199 ], [ -122.320422, 47.602204 ], [ -122.320168, 47.602029 ], [ -122.320173, 47.601367 ], [ -122.320885, 47.60122 ], [ -122.321158, 47.601358 ], [ -122.321151, 47.602199 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326705, 47.598753 ], [ -122.327243, 47.598756 ], [ -122.327323, 47.598898 ], [ -122.327233, 47.599198 ], [ -122.326704, 47.599195 ], [ -122.326668, 47.598784 ], [ -122.326705, 47.598753 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329471, 47.605233 ], [ -122.328782, 47.605836 ], [ -122.328582, 47.605614 ], [ -122.329459, 47.604846 ], [ -122.329508, 47.604887 ], [ -122.329471, 47.605233 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333563, 47.602259 ], [ -122.333198, 47.601773 ], [ -122.3332, 47.601311 ], [ -122.333566, 47.601313 ], [ -122.333563, 47.602259 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332528, 47.606768 ], [ -122.332748, 47.60729 ], [ -122.332396, 47.607607 ], [ -122.332114, 47.606935 ], [ -122.332186, 47.606871 ], [ -122.332528, 47.606768 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320132, 47.603949 ], [ -122.319741, 47.603949 ], [ -122.319718, 47.603931 ], [ -122.319705, 47.603144 ], [ -122.319745, 47.603114 ], [ -122.320143, 47.603116 ], [ -122.320132, 47.603949 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331026, 47.603702 ], [ -122.331118, 47.603925 ], [ -122.3307, 47.604317 ], [ -122.330603, 47.604085 ], [ -122.331026, 47.603702 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330784, 47.604616 ], [ -122.330733, 47.604575 ], [ -122.331303, 47.604038 ], [ -122.331734, 47.604096 ], [ -122.331721, 47.604168 ], [ -122.331369, 47.604503 ], [ -122.330784, 47.604616 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331263, 47.605288 ], [ -122.331236, 47.605375 ], [ -122.330809, 47.605761 ], [ -122.330356, 47.605646 ], [ -122.330363, 47.60551 ], [ -122.330937, 47.604991 ], [ -122.331263, 47.605288 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32559, 47.596257 ], [ -122.325591, 47.595779 ], [ -122.326065, 47.595682 ], [ -122.326064, 47.59601 ], [ -122.325948, 47.596234 ], [ -122.325855, 47.596261 ], [ -122.32559, 47.596257 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332798, 47.6029 ], [ -122.332351, 47.602846 ], [ -122.332343, 47.602673 ], [ -122.332805, 47.602226 ], [ -122.333189, 47.602548 ], [ -122.332798, 47.6029 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331007, 47.601305 ], [ -122.331052, 47.601204 ], [ -122.331378, 47.600913 ], [ -122.331827, 47.601279 ], [ -122.331587, 47.601506 ], [ -122.331058, 47.601343 ], [ -122.331007, 47.601305 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323852, 47.605455 ], [ -122.323777, 47.605482 ], [ -122.323356, 47.605382 ], [ -122.323117, 47.604808 ], [ -122.323315, 47.604594 ], [ -122.32361, 47.604776 ], [ -122.32388, 47.60543 ], [ -122.323852, 47.605455 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330287, 47.60373 ], [ -122.330603, 47.604085 ], [ -122.3307, 47.604317 ], [ -122.330731, 47.604575 ], [ -122.330564, 47.604621 ], [ -122.330099, 47.604379 ], [ -122.329937, 47.603986 ], [ -122.329997, 47.603728 ], [ -122.330287, 47.60373 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327287, 47.602417 ], [ -122.325985, 47.60332 ], [ -122.325945, 47.603293 ], [ -122.325673, 47.602907 ], [ -122.32685, 47.602095 ], [ -122.327268, 47.602312 ], [ -122.327287, 47.602417 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326919, 47.606093 ], [ -122.326949, 47.606064 ], [ -122.327289, 47.606031 ], [ -122.327606, 47.606793 ], [ -122.327403, 47.606979 ], [ -122.327292, 47.606993 ], [ -122.326919, 47.606093 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324065, 47.599947 ], [ -122.322904, 47.599955 ], [ -122.323091, 47.59978 ], [ -122.324098, 47.599799 ], [ -122.324065, 47.599947 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326551, 47.596459 ], [ -122.326547, 47.596589 ], [ -122.326183, 47.596581 ], [ -122.326137, 47.596478 ], [ -122.326551, 47.596459 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33454, 47.599742 ], [ -122.334542, 47.600473 ], [ -122.334537, 47.600476 ], [ -122.334186, 47.600473 ], [ -122.334193, 47.599743 ], [ -122.33454, 47.599742 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328425, 47.608608 ], [ -122.328463, 47.608623 ], [ -122.328686, 47.609164 ], [ -122.32807, 47.609739 ], [ -122.327945, 47.609731 ], [ -122.32765, 47.609029 ], [ -122.328066, 47.608643 ], [ -122.328425, 47.608608 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334462, 47.603975 ], [ -122.334094, 47.603636 ], [ -122.333936, 47.603241 ], [ -122.334172, 47.603035 ], [ -122.334502, 47.603015 ], [ -122.334776, 47.603684 ], [ -122.334762, 47.603934 ], [ -122.334462, 47.603975 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328807, 47.608304 ], [ -122.328457, 47.60748 ], [ -122.328723, 47.607346 ], [ -122.329081, 47.608188 ], [ -122.328807, 47.608304 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.066666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324162, 47.599662 ], [ -122.324197, 47.599606 ], [ -122.324584, 47.599608 ], [ -122.324666, 47.599763 ], [ -122.324716, 47.599931 ], [ -122.324713, 47.600975 ], [ -122.324063, 47.600831 ], [ -122.324065, 47.599947 ], [ -122.324098, 47.599799 ], [ -122.324162, 47.599662 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333834, 47.601141 ], [ -122.334184, 47.601142 ], [ -122.334538, 47.601219 ], [ -122.334608, 47.601319 ], [ -122.334543, 47.601458 ], [ -122.334178, 47.601565 ], [ -122.333863, 47.601562 ], [ -122.333697, 47.601304 ], [ -122.333834, 47.601141 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329508, 47.604887 ], [ -122.329459, 47.604846 ], [ -122.329267, 47.604616 ], [ -122.329937, 47.603986 ], [ -122.330099, 47.604379 ], [ -122.32955, 47.604888 ], [ -122.329508, 47.604887 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327151, 47.607958 ], [ -122.326813, 47.607124 ], [ -122.327292, 47.606993 ], [ -122.327403, 47.606979 ], [ -122.327715, 47.607729 ], [ -122.327615, 47.607819 ], [ -122.327335, 47.607945 ], [ -122.327151, 47.607958 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329528, 47.600464 ], [ -122.329847, 47.600461 ], [ -122.329958, 47.600579 ], [ -122.329961, 47.601049 ], [ -122.329904, 47.601155 ], [ -122.329524, 47.601256 ], [ -122.329528, 47.600464 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332434, 47.604837 ], [ -122.3326, 47.604685 ], [ -122.332676, 47.604678 ], [ -122.333051, 47.605595 ], [ -122.332787, 47.605623 ], [ -122.332525, 47.605211 ], [ -122.332431, 47.604983 ], [ -122.332434, 47.604837 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322133, 47.598929 ], [ -122.321924, 47.59865 ], [ -122.32195, 47.598598 ], [ -122.322779, 47.598608 ], [ -122.322866, 47.598729 ], [ -122.322771, 47.598926 ], [ -122.322133, 47.598929 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328261, 47.6075 ], [ -122.328104, 47.60713 ], [ -122.32855, 47.606718 ], [ -122.328783, 47.60729 ], [ -122.328723, 47.607346 ], [ -122.328457, 47.60748 ], [ -122.328261, 47.6075 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1111111111111111 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323261, 47.600975 ], [ -122.324063, 47.600831 ], [ -122.324713, 47.600975 ], [ -122.32487, 47.601069 ], [ -122.324867, 47.602201 ], [ -122.323391, 47.602347 ], [ -122.323365, 47.602292 ], [ -122.323256, 47.601947 ], [ -122.323261, 47.600975 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322207, 47.599105 ], [ -122.322731, 47.599105 ], [ -122.322832, 47.600011 ], [ -122.322653, 47.600293 ], [ -122.322282, 47.600131 ], [ -122.322196, 47.600077 ], [ -122.322207, 47.599105 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33679, 47.600854 ], [ -122.337014, 47.602048 ], [ -122.336478, 47.602175 ], [ -122.336472, 47.601157 ], [ -122.33679, 47.600854 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.22222222222222221 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319994, 47.600841 ], [ -122.319967, 47.600328 ], [ -122.320097, 47.600019 ], [ -122.320331, 47.599883 ], [ -122.320794, 47.600009 ], [ -122.320891, 47.600802 ], [ -122.320885, 47.60122 ], [ -122.320173, 47.601367 ], [ -122.320138, 47.601326 ], [ -122.319994, 47.600841 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32094, 47.606639 ], [ -122.321092, 47.606357 ], [ -122.321106, 47.606346 ], [ -122.321184, 47.60639 ], [ -122.32135, 47.60677 ], [ -122.321072, 47.607024 ], [ -122.32094, 47.606639 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.51111111111111107 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335013, 47.602552 ], [ -122.335047, 47.602464 ], [ -122.335197, 47.602383 ], [ -122.335577, 47.602381 ], [ -122.335871, 47.603117 ], [ -122.335893, 47.603371 ], [ -122.335753, 47.6035 ], [ -122.33572, 47.603502 ], [ -122.335281, 47.603226 ], [ -122.335013, 47.602552 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326484, 47.609343 ], [ -122.326488, 47.609317 ], [ -122.326572, 47.609239 ], [ -122.326853, 47.609115 ], [ -122.327033, 47.609098 ], [ -122.327279, 47.609686 ], [ -122.327008, 47.609668 ], [ -122.326583, 47.609582 ], [ -122.326484, 47.609343 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321496, 47.603135 ], [ -122.321435, 47.603192 ], [ -122.320499, 47.603202 ], [ -122.320353, 47.60308 ], [ -122.320419, 47.602788 ], [ -122.321458, 47.602777 ], [ -122.321496, 47.603135 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336284, 47.59964 ], [ -122.336075, 47.599489 ], [ -122.336105, 47.598843 ], [ -122.336248, 47.598759 ], [ -122.336383, 47.599234 ], [ -122.336284, 47.59964 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321665, 47.605315 ], [ -122.32136, 47.604576 ], [ -122.321527, 47.604415 ], [ -122.321965, 47.604448 ], [ -122.322231, 47.605085 ], [ -122.32201, 47.605286 ], [ -122.321665, 47.605315 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331084, 47.606318 ], [ -122.331485, 47.605956 ], [ -122.331951, 47.60598 ], [ -122.331912, 47.606216 ], [ -122.331505, 47.606585 ], [ -122.331084, 47.606318 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322731, 47.599105 ], [ -122.322207, 47.599105 ], [ -122.322133, 47.598929 ], [ -122.322771, 47.598926 ], [ -122.322731, 47.599105 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337653, 47.603812 ], [ -122.337892, 47.604385 ], [ -122.337577, 47.604678 ], [ -122.337251, 47.604723 ], [ -122.337078, 47.604301 ], [ -122.337624, 47.603803 ], [ -122.337653, 47.603812 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329847, 47.600461 ], [ -122.329959, 47.60016 ], [ -122.330359, 47.600161 ], [ -122.330543, 47.600281 ], [ -122.33046, 47.600582 ], [ -122.329958, 47.600579 ], [ -122.329847, 47.600461 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335422, 47.601281 ], [ -122.335813, 47.601105 ], [ -122.336452, 47.601165 ], [ -122.335893, 47.601685 ], [ -122.335422, 47.601281 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325382, 47.607715 ], [ -122.325069, 47.606965 ], [ -122.325284, 47.606767 ], [ -122.325624, 47.60673 ], [ -122.326007, 47.60765 ], [ -122.325382, 47.607715 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.07575757575757576 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328645, 47.599803 ], [ -122.328669, 47.599994 ], [ -122.328668, 47.600373 ], [ -122.328637, 47.600404 ], [ -122.328433, 47.600456 ], [ -122.328072, 47.600454 ], [ -122.327995, 47.60038 ], [ -122.327997, 47.599839 ], [ -122.328121, 47.599635 ], [ -122.32822, 47.599598 ], [ -122.328559, 47.599643 ], [ -122.328645, 47.599803 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5357142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326668, 47.598784 ], [ -122.326704, 47.599195 ], [ -122.326676, 47.599508 ], [ -122.326584, 47.599614 ], [ -122.326037, 47.599611 ], [ -122.326039, 47.598783 ], [ -122.326042, 47.59878 ], [ -122.326668, 47.598784 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.39285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337669, 47.605631 ], [ -122.33798, 47.606376 ], [ -122.337527, 47.606788 ], [ -122.337266, 47.60669 ], [ -122.336969, 47.606303 ], [ -122.336874, 47.606075 ], [ -122.337338, 47.605654 ], [ -122.337669, 47.605631 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326035, 47.596304 ], [ -122.326579, 47.596311 ], [ -122.326551, 47.596459 ], [ -122.326137, 47.596478 ], [ -122.326035, 47.596304 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335249, 47.59965 ], [ -122.334657, 47.599631 ], [ -122.334554, 47.599327 ], [ -122.334555, 47.599044 ], [ -122.33527, 47.599153 ], [ -122.335273, 47.599627 ], [ -122.335249, 47.59965 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335266, 47.601252 ], [ -122.335268, 47.600763 ], [ -122.335818, 47.600689 ], [ -122.335813, 47.601105 ], [ -122.335422, 47.601281 ], [ -122.335266, 47.601252 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324063, 47.600831 ], [ -122.323261, 47.600975 ], [ -122.322796, 47.60063 ], [ -122.322653, 47.600293 ], [ -122.322832, 47.600011 ], [ -122.322904, 47.599955 ], [ -122.324065, 47.599947 ], [ -122.324063, 47.600831 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.339796, 47.60274 ], [ -122.339627, 47.603903 ], [ -122.33902, 47.603784 ], [ -122.338653, 47.603405 ], [ -122.338629, 47.602731 ], [ -122.339796, 47.60274 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.53333333333333333 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32487, 47.601069 ], [ -122.324713, 47.600975 ], [ -122.324716, 47.599931 ], [ -122.325366, 47.599935 ], [ -122.325363, 47.60087 ], [ -122.32487, 47.601069 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333335, 47.608416 ], [ -122.333624, 47.609105 ], [ -122.333331, 47.609211 ], [ -122.333015, 47.608457 ], [ -122.333335, 47.608416 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325852, 47.5971 ], [ -122.325386, 47.597097 ], [ -122.325389, 47.596325 ], [ -122.32559, 47.596257 ], [ -122.325855, 47.596261 ], [ -122.325852, 47.5971 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336485, 47.607407 ], [ -122.337266, 47.60669 ], [ -122.337527, 47.606788 ], [ -122.337591, 47.606942 ], [ -122.336681, 47.60769 ], [ -122.336617, 47.607725 ], [ -122.336485, 47.607407 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329444, 47.606333 ], [ -122.328913, 47.606135 ], [ -122.328782, 47.605836 ], [ -122.329471, 47.605233 ], [ -122.329755, 47.605926 ], [ -122.329444, 47.606333 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322743, 47.604889 ], [ -122.322394, 47.604057 ], [ -122.322444, 47.603916 ], [ -122.32344, 47.603899 ], [ -122.323315, 47.604594 ], [ -122.323117, 47.604808 ], [ -122.322743, 47.604889 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325212, 47.605792 ], [ -122.325559, 47.60578 ], [ -122.325868, 47.606509 ], [ -122.325624, 47.60673 ], [ -122.325284, 47.606767 ], [ -122.32497, 47.606016 ], [ -122.325212, 47.605792 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5357142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332495, 47.603745 ], [ -122.332837, 47.603709 ], [ -122.333157, 47.604452 ], [ -122.332982, 47.604615 ], [ -122.332676, 47.604678 ], [ -122.3326, 47.604685 ], [ -122.332279, 47.603941 ], [ -122.332495, 47.603745 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331682, 47.608373 ], [ -122.331337, 47.608306 ], [ -122.331852, 47.607827 ], [ -122.332121, 47.607952 ], [ -122.332119, 47.607964 ], [ -122.331682, 47.608373 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.083333333333333329 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326183, 47.596581 ], [ -122.326182, 47.5971 ], [ -122.32605, 47.597162 ], [ -122.325852, 47.5971 ], [ -122.325855, 47.596261 ], [ -122.325948, 47.596234 ], [ -122.326035, 47.596304 ], [ -122.326137, 47.596478 ], [ -122.326183, 47.596581 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332759, 47.608844 ], [ -122.332954, 47.609308 ], [ -122.332663, 47.609367 ], [ -122.332475, 47.6091 ], [ -122.332759, 47.608844 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329411, 47.601464 ], [ -122.32863, 47.60147 ], [ -122.328841, 47.60114 ], [ -122.32921, 47.601138 ], [ -122.329435, 47.601313 ], [ -122.329411, 47.601464 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330733, 47.604575 ], [ -122.330784, 47.604616 ], [ -122.330937, 47.604991 ], [ -122.330363, 47.60551 ], [ -122.330154, 47.605 ], [ -122.330564, 47.604621 ], [ -122.330731, 47.604575 ], [ -122.330733, 47.604575 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332937, 47.608502 ], [ -122.333247, 47.609241 ], [ -122.333202, 47.609257 ], [ -122.332954, 47.609308 ], [ -122.332759, 47.608844 ], [ -122.332773, 47.608613 ], [ -122.332937, 47.608502 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328223, 47.598692 ], [ -122.32822, 47.599598 ], [ -122.328121, 47.599635 ], [ -122.327841, 47.599421 ], [ -122.327842, 47.598988 ], [ -122.328223, 47.598692 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319745, 47.604792 ], [ -122.319743, 47.605712 ], [ -122.319485, 47.605711 ], [ -122.319371, 47.605568 ], [ -122.319373, 47.604791 ], [ -122.319378, 47.60479 ], [ -122.31974, 47.604788 ], [ -122.319745, 47.604792 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336312, 47.599671 ], [ -122.336391, 47.599886 ], [ -122.335789, 47.599916 ], [ -122.335452, 47.59963 ], [ -122.335784, 47.599496 ], [ -122.336075, 47.599489 ], [ -122.336284, 47.59964 ], [ -122.336312, 47.599671 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331915, 47.598523 ], [ -122.331917, 47.59782 ], [ -122.332571, 47.597387 ], [ -122.332567, 47.598518 ], [ -122.332562, 47.598526 ], [ -122.331915, 47.598523 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326572, 47.609239 ], [ -122.326488, 47.609317 ], [ -122.326027, 47.609106 ], [ -122.325824, 47.608619 ], [ -122.326183, 47.608287 ], [ -122.326572, 47.609239 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335642, 47.606375 ], [ -122.336013, 47.607267 ], [ -122.335672, 47.607383 ], [ -122.335285, 47.606439 ], [ -122.335337, 47.606344 ], [ -122.335642, 47.606375 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333005, 47.603551 ], [ -122.332981, 47.603346 ], [ -122.333456, 47.60291 ], [ -122.333776, 47.603254 ], [ -122.333429, 47.603573 ], [ -122.333005, 47.603551 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321092, 47.606357 ], [ -122.32094, 47.606639 ], [ -122.320323, 47.606633 ], [ -122.320436, 47.606314 ], [ -122.321092, 47.606357 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328192, 47.601535 ], [ -122.328064, 47.601353 ], [ -122.328425, 47.600985 ], [ -122.328772, 47.60098 ], [ -122.328841, 47.60114 ], [ -122.32863, 47.60147 ], [ -122.328531, 47.601575 ], [ -122.328192, 47.601535 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7142857142857143 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325497, 47.60087 ], [ -122.326031, 47.600458 ], [ -122.326694, 47.600458 ], [ -122.326697, 47.60046 ], [ -122.326691, 47.601304 ], [ -122.32603, 47.601294 ], [ -122.325497, 47.60087 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3307, 47.604317 ], [ -122.331118, 47.603925 ], [ -122.331303, 47.604038 ], [ -122.330733, 47.604575 ], [ -122.330731, 47.604575 ], [ -122.3307, 47.604317 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337577, 47.604678 ], [ -122.337894, 47.605432 ], [ -122.337669, 47.605631 ], [ -122.337338, 47.605654 ], [ -122.337028, 47.604917 ], [ -122.337251, 47.604723 ], [ -122.337577, 47.604678 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5357142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322102, 47.602315 ], [ -122.322625, 47.602926 ], [ -122.322132, 47.603374 ], [ -122.321496, 47.603135 ], [ -122.321458, 47.602777 ], [ -122.321459, 47.602437 ], [ -122.321895, 47.602179 ], [ -122.322102, 47.602315 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334803, 47.597513 ], [ -122.334781, 47.597438 ], [ -122.3349, 47.597224 ], [ -122.335022, 47.597128 ], [ -122.336707, 47.59749 ], [ -122.336755, 47.597529 ], [ -122.334956, 47.597652 ], [ -122.334803, 47.597513 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336248, 47.598759 ], [ -122.336743, 47.59832 ], [ -122.337277, 47.597958 ], [ -122.337812, 47.598398 ], [ -122.336719, 47.599224 ], [ -122.336383, 47.599234 ], [ -122.336248, 47.598759 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329427, 47.598966 ], [ -122.329719, 47.598679 ], [ -122.329976, 47.599045 ], [ -122.329976, 47.599085 ], [ -122.329444, 47.599575 ], [ -122.329425, 47.599547 ], [ -122.329427, 47.598966 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323544, 47.599197 ], [ -122.324069, 47.5992 ], [ -122.324086, 47.599389 ], [ -122.32349, 47.599385 ], [ -122.323544, 47.599197 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326852, 47.595896 ], [ -122.327366, 47.595897 ], [ -122.327382, 47.595985 ], [ -122.32734, 47.596098 ], [ -122.326994, 47.596215 ], [ -122.326847, 47.596221 ], [ -122.326754, 47.596172 ], [ -122.326852, 47.595896 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32135, 47.60677 ], [ -122.321812, 47.606736 ], [ -122.321832, 47.606782 ], [ -122.321172, 47.607406 ], [ -122.321016, 47.607277 ], [ -122.321072, 47.607024 ], [ -122.32135, 47.60677 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323973, 47.608213 ], [ -122.324231, 47.608012 ], [ -122.324799, 47.608114 ], [ -122.323947, 47.608879 ], [ -122.323934, 47.608874 ], [ -122.32372, 47.60861 ], [ -122.3238, 47.608395 ], [ -122.323973, 47.608213 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324077, 47.598143 ], [ -122.323952, 47.59794 ], [ -122.324081, 47.597732 ], [ -122.324731, 47.597725 ], [ -122.324878, 47.597942 ], [ -122.324727, 47.598159 ], [ -122.324077, 47.598143 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5357142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328463, 47.608623 ], [ -122.328807, 47.608304 ], [ -122.329081, 47.608188 ], [ -122.329249, 47.608168 ], [ -122.329568, 47.608923 ], [ -122.329128, 47.609336 ], [ -122.328686, 47.609164 ], [ -122.328463, 47.608623 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319745, 47.603114 ], [ -122.319748, 47.602231 ], [ -122.320168, 47.602029 ], [ -122.320422, 47.602204 ], [ -122.320419, 47.602788 ], [ -122.320353, 47.60308 ], [ -122.320143, 47.603116 ], [ -122.319745, 47.603114 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322216, 47.605777 ], [ -122.32201, 47.605286 ], [ -122.322231, 47.605085 ], [ -122.322573, 47.605046 ], [ -122.322886, 47.605796 ], [ -122.322663, 47.605992 ], [ -122.322216, 47.605777 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326487, 47.608208 ], [ -122.326853, 47.609115 ], [ -122.326572, 47.609239 ], [ -122.326183, 47.608287 ], [ -122.326255, 47.60817 ], [ -122.326487, 47.608208 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.035714285714285712 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331232, 47.609205 ], [ -122.331618, 47.609537 ], [ -122.331626, 47.609579 ], [ -122.331191, 47.609668 ], [ -122.330414, 47.60972 ], [ -122.330343, 47.609531 ], [ -122.330585, 47.609324 ], [ -122.331232, 47.609205 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333841, 47.598887 ], [ -122.33451, 47.598884 ], [ -122.334513, 47.598935 ], [ -122.33419, 47.599116 ], [ -122.33396, 47.599116 ], [ -122.333826, 47.598921 ], [ -122.333841, 47.598887 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330594, 47.607661 ], [ -122.330246, 47.607529 ], [ -122.32999, 47.606922 ], [ -122.330553, 47.606555 ], [ -122.330748, 47.606538 ], [ -122.331075, 47.607319 ], [ -122.330594, 47.607661 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331827, 47.601279 ], [ -122.331378, 47.600913 ], [ -122.33138, 47.600462 ], [ -122.331905, 47.600471 ], [ -122.331901, 47.601243 ], [ -122.331827, 47.601279 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334196, 47.598136 ], [ -122.334195, 47.598534 ], [ -122.333841, 47.598535 ], [ -122.333842, 47.598137 ], [ -122.334196, 47.598136 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32403, 47.605882 ], [ -122.324124, 47.605965 ], [ -122.324276, 47.606327 ], [ -122.324152, 47.606388 ], [ -122.323828, 47.606066 ], [ -122.32403, 47.605882 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323246, 47.597092 ], [ -122.323248, 47.596531 ], [ -122.323565, 47.596417 ], [ -122.323563, 47.597092 ], [ -122.323429, 47.59715 ], [ -122.323246, 47.597092 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326718, 47.596173 ], [ -122.326547, 47.596011 ], [ -122.326548, 47.595674 ], [ -122.326833, 47.595728 ], [ -122.326853, 47.595763 ], [ -122.326852, 47.595896 ], [ -122.326754, 47.596172 ], [ -122.326718, 47.596173 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.53333333333333333 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319748, 47.602231 ], [ -122.319745, 47.603114 ], [ -122.319705, 47.603144 ], [ -122.319252, 47.603109 ], [ -122.319318, 47.602166 ], [ -122.319748, 47.602231 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329956, 47.599982 ], [ -122.330158, 47.599936 ], [ -122.33038, 47.599938 ], [ -122.330359, 47.600022 ], [ -122.329959, 47.600031 ], [ -122.329956, 47.599982 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.338914, 47.601912 ], [ -122.338931, 47.601902 ], [ -122.339715, 47.601864 ], [ -122.339756, 47.602142 ], [ -122.338946, 47.602086 ], [ -122.338914, 47.601912 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322657, 47.606026 ], [ -122.3223, 47.606352 ], [ -122.32184, 47.606404 ], [ -122.3218, 47.606158 ], [ -122.322216, 47.605777 ], [ -122.322663, 47.605992 ], [ -122.322657, 47.606026 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33451, 47.598884 ], [ -122.334575, 47.598646 ], [ -122.334578, 47.598642 ], [ -122.335201, 47.598641 ], [ -122.335337, 47.598945 ], [ -122.33527, 47.599153 ], [ -122.334555, 47.599044 ], [ -122.334513, 47.598935 ], [ -122.33451, 47.598884 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.22222222222222221 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327634, 47.604659 ], [ -122.32761, 47.604708 ], [ -122.327184, 47.605077 ], [ -122.326558, 47.605139 ], [ -122.326533, 47.605129 ], [ -122.326226, 47.604395 ], [ -122.326372, 47.603792 ], [ -122.326569, 47.603794 ], [ -122.327398, 47.604102 ], [ -122.327634, 47.604659 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32446, 47.605655 ], [ -122.32476, 47.606039 ], [ -122.324448, 47.606327 ], [ -122.324276, 47.606327 ], [ -122.324124, 47.605965 ], [ -122.32446, 47.605655 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337812, 47.598398 ], [ -122.338012, 47.598563 ], [ -122.338779, 47.59953 ], [ -122.33841, 47.599913 ], [ -122.337785, 47.60027 ], [ -122.33742, 47.600437 ], [ -122.336975, 47.600539 ], [ -122.336598, 47.600166 ], [ -122.336391, 47.599886 ], [ -122.336312, 47.599671 ], [ -122.336719, 47.599224 ], [ -122.337812, 47.598398 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.083333333333333329 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334584, 47.597988 ], [ -122.334803, 47.597513 ], [ -122.334956, 47.597652 ], [ -122.335112, 47.597829 ], [ -122.335254, 47.598088 ], [ -122.335273, 47.598473 ], [ -122.335201, 47.598641 ], [ -122.334578, 47.598642 ], [ -122.334584, 47.597988 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332758, 47.60792 ], [ -122.33323, 47.607492 ], [ -122.333536, 47.608234 ], [ -122.333335, 47.608416 ], [ -122.333015, 47.608457 ], [ -122.332986, 47.608459 ], [ -122.332758, 47.60792 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.46666666666666667 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329421, 47.601818 ], [ -122.329067, 47.602049 ], [ -122.329022, 47.601631 ], [ -122.329414, 47.601561 ], [ -122.329422, 47.601592 ], [ -122.329421, 47.601818 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.26666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334485, 47.596569 ], [ -122.332895, 47.596885 ], [ -122.332517, 47.59576 ], [ -122.333201, 47.5959 ], [ -122.334486, 47.596363 ], [ -122.334485, 47.596569 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327016, 47.595536 ], [ -122.327041, 47.595487 ], [ -122.327556, 47.595453 ], [ -122.327364, 47.59584 ], [ -122.327222, 47.595764 ], [ -122.327016, 47.595536 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329976, 47.599085 ], [ -122.330071, 47.599337 ], [ -122.329684, 47.599693 ], [ -122.329463, 47.599628 ], [ -122.329444, 47.599575 ], [ -122.329976, 47.599085 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324096, 47.598775 ], [ -122.324069, 47.5992 ], [ -122.323544, 47.599197 ], [ -122.323548, 47.598753 ], [ -122.324075, 47.598756 ], [ -122.324096, 47.598775 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.054545454545454543 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329463, 47.599628 ], [ -122.329684, 47.599693 ], [ -122.329921, 47.599885 ], [ -122.329956, 47.599982 ], [ -122.329959, 47.600031 ], [ -122.329959, 47.60016 ], [ -122.329847, 47.600461 ], [ -122.329528, 47.600464 ], [ -122.329377, 47.600424 ], [ -122.329379, 47.599764 ], [ -122.329463, 47.599628 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334005, 47.607064 ], [ -122.333741, 47.606436 ], [ -122.333743, 47.606133 ], [ -122.334245, 47.606087 ], [ -122.334554, 47.606823 ], [ -122.334361, 47.607001 ], [ -122.334069, 47.607056 ], [ -122.334005, 47.607064 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327841, 47.599421 ], [ -122.327597, 47.599419 ], [ -122.327496, 47.598986 ], [ -122.327842, 47.598988 ], [ -122.327841, 47.599421 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335781, 47.605399 ], [ -122.335174, 47.605956 ], [ -122.334973, 47.605829 ], [ -122.334957, 47.605496 ], [ -122.335397, 47.605092 ], [ -122.335781, 47.605399 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327348, 47.600376 ], [ -122.327254, 47.600463 ], [ -122.326697, 47.60046 ], [ -122.326694, 47.600458 ], [ -122.326696, 47.599897 ], [ -122.32735, 47.599901 ], [ -122.327348, 47.600376 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329099, 47.599232 ], [ -122.329099, 47.599043 ], [ -122.329275, 47.598961 ], [ -122.329427, 47.598966 ], [ -122.329425, 47.599547 ], [ -122.329179, 47.59946 ], [ -122.329099, 47.599232 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33181, 47.603988 ], [ -122.331734, 47.604096 ], [ -122.331303, 47.604038 ], [ -122.331118, 47.603925 ], [ -122.331026, 47.603702 ], [ -122.331051, 47.603246 ], [ -122.331536, 47.603316 ], [ -122.33181, 47.603988 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324858, 47.60473 ], [ -122.325431, 47.604774 ], [ -122.325775, 47.605582 ], [ -122.325559, 47.60578 ], [ -122.325212, 47.605792 ], [ -122.324813, 47.604856 ], [ -122.324858, 47.60473 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.42857142857142855 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334172, 47.603035 ], [ -122.333904, 47.602401 ], [ -122.33475, 47.60226 ], [ -122.335047, 47.602464 ], [ -122.335013, 47.602552 ], [ -122.334502, 47.603015 ], [ -122.334172, 47.603035 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.090909090909090912 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332237, 47.602422 ], [ -122.332343, 47.602673 ], [ -122.332351, 47.602846 ], [ -122.332191, 47.602994 ], [ -122.331847, 47.603033 ], [ -122.331502, 47.602207 ], [ -122.331585, 47.60213 ], [ -122.331775, 47.602133 ], [ -122.331945, 47.602199 ], [ -122.332074, 47.602253 ], [ -122.332237, 47.602422 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32605, 47.597162 ], [ -122.326048, 47.597945 ], [ -122.326045, 47.597947 ], [ -122.325381, 47.597943 ], [ -122.325383, 47.597099 ], [ -122.325386, 47.597097 ], [ -122.325852, 47.5971 ], [ -122.32605, 47.597162 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.18181818181818182 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328243, 47.596898 ], [ -122.328358, 47.597347 ], [ -122.32836, 47.597705 ], [ -122.328296, 47.597955 ], [ -122.327361, 47.597949 ], [ -122.327032, 47.597696 ], [ -122.327033, 47.597208 ], [ -122.327322, 47.597024 ], [ -122.327649, 47.596869 ], [ -122.328153, 47.596872 ], [ -122.328243, 47.596898 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319741, 47.603949 ], [ -122.31974, 47.604788 ], [ -122.319378, 47.60479 ], [ -122.319381, 47.603955 ], [ -122.319718, 47.603931 ], [ -122.319741, 47.603949 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336719, 47.599224 ], [ -122.336312, 47.599671 ], [ -122.336284, 47.59964 ], [ -122.336383, 47.599234 ], [ -122.336719, 47.599224 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332571, 47.597387 ], [ -122.332906, 47.596937 ], [ -122.333077, 47.59709 ], [ -122.333072, 47.598523 ], [ -122.332567, 47.598518 ], [ -122.332571, 47.597387 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330872, 47.601911 ], [ -122.330551, 47.601884 ], [ -122.330555, 47.60147 ], [ -122.330705, 47.601304 ], [ -122.33087, 47.601306 ], [ -122.330876, 47.601307 ], [ -122.330872, 47.601911 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334226, 47.608216 ], [ -122.333961, 47.608187 ], [ -122.333586, 47.607276 ], [ -122.333885, 47.607175 ], [ -122.334276, 47.608125 ], [ -122.334226, 47.608216 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33398, 47.599435 ], [ -122.334187, 47.599325 ], [ -122.334554, 47.599327 ], [ -122.334657, 47.599631 ], [ -122.33454, 47.599742 ], [ -122.334193, 47.599743 ], [ -122.333872, 47.599686 ], [ -122.33398, 47.599435 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334543, 47.601458 ], [ -122.334542, 47.601934 ], [ -122.334178, 47.601936 ], [ -122.334178, 47.601565 ], [ -122.334543, 47.601458 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.41666666666666669 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322625, 47.602926 ], [ -122.323293, 47.602724 ], [ -122.323689, 47.603663 ], [ -122.323689, 47.60367 ], [ -122.32344, 47.603899 ], [ -122.322444, 47.603916 ], [ -122.322225, 47.603593 ], [ -122.322132, 47.603374 ], [ -122.322625, 47.602926 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332544, 47.601315 ], [ -122.332551, 47.60131 ], [ -122.3332, 47.60131 ], [ -122.3332, 47.601311 ], [ -122.333198, 47.601773 ], [ -122.332728, 47.602042 ], [ -122.332681, 47.602014 ], [ -122.332544, 47.601853 ], [ -122.332544, 47.601315 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326704, 47.599195 ], [ -122.327233, 47.599198 ], [ -122.327232, 47.599512 ], [ -122.326676, 47.599508 ], [ -122.326704, 47.599195 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32349, 47.599385 ], [ -122.324086, 47.599389 ], [ -122.324174, 47.599569 ], [ -122.32331, 47.599563 ], [ -122.32349, 47.599385 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332681, 47.602014 ], [ -122.332237, 47.602422 ], [ -122.332074, 47.602253 ], [ -122.332489, 47.601872 ], [ -122.332544, 47.601853 ], [ -122.332681, 47.602014 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334776, 47.603684 ], [ -122.335281, 47.603226 ], [ -122.33572, 47.603502 ], [ -122.335019, 47.604136 ], [ -122.334998, 47.604124 ], [ -122.334762, 47.603934 ], [ -122.334776, 47.603684 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324152, 47.606388 ], [ -122.323926, 47.60659 ], [ -122.323476, 47.606559 ], [ -122.32346, 47.606354 ], [ -122.323788, 47.606061 ], [ -122.323828, 47.606066 ], [ -122.324152, 47.606388 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325985, 47.60332 ], [ -122.326372, 47.603792 ], [ -122.326226, 47.604395 ], [ -122.325431, 47.604774 ], [ -122.324858, 47.60473 ], [ -122.324715, 47.604413 ], [ -122.325945, 47.603293 ], [ -122.325985, 47.60332 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331734, 47.604096 ], [ -122.33181, 47.603988 ], [ -122.332279, 47.603941 ], [ -122.3326, 47.604685 ], [ -122.332434, 47.604837 ], [ -122.331975, 47.604757 ], [ -122.331721, 47.604168 ], [ -122.331734, 47.604096 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322018, 47.601945 ], [ -122.323256, 47.601947 ], [ -122.323365, 47.602292 ], [ -122.322102, 47.602315 ], [ -122.321895, 47.602179 ], [ -122.322018, 47.601945 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.19047619047619047 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333861, 47.60202 ], [ -122.334178, 47.601936 ], [ -122.334542, 47.601934 ], [ -122.33475, 47.60226 ], [ -122.333904, 47.602401 ], [ -122.333712, 47.602254 ], [ -122.333861, 47.60202 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.338944, 47.602334 ], [ -122.339785, 47.60234 ], [ -122.33982, 47.602578 ], [ -122.339796, 47.60274 ], [ -122.338629, 47.602731 ], [ -122.338615, 47.6027 ], [ -122.338944, 47.602334 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331775, 47.602133 ], [ -122.332099, 47.601827 ], [ -122.332306, 47.601856 ], [ -122.331945, 47.602199 ], [ -122.331775, 47.602133 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328975, 47.598663 ], [ -122.329764, 47.598225 ], [ -122.329719, 47.598679 ], [ -122.329427, 47.598966 ], [ -122.329275, 47.598961 ], [ -122.328975, 47.598663 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333586, 47.607276 ], [ -122.333961, 47.608187 ], [ -122.333536, 47.608234 ], [ -122.33323, 47.607492 ], [ -122.333232, 47.607483 ], [ -122.333445, 47.607287 ], [ -122.333586, 47.607276 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332681, 47.602014 ], [ -122.332728, 47.602042 ], [ -122.332805, 47.602226 ], [ -122.332343, 47.602673 ], [ -122.332237, 47.602422 ], [ -122.332681, 47.602014 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334957, 47.605496 ], [ -122.334745, 47.605 ], [ -122.335189, 47.604593 ], [ -122.335397, 47.605092 ], [ -122.334957, 47.605496 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325413, 47.599768 ], [ -122.325366, 47.599935 ], [ -122.324716, 47.599931 ], [ -122.324666, 47.599763 ], [ -122.325413, 47.599768 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.83333333333333337 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322949, 47.608376 ], [ -122.323008, 47.608514 ], [ -122.322876, 47.608441 ], [ -122.322949, 47.608376 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327818, 47.605802 ], [ -122.327506, 47.605839 ], [ -122.327184, 47.605077 ], [ -122.32761, 47.604708 ], [ -122.328007, 47.605642 ], [ -122.327818, 47.605802 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1388888888888889 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328583, 47.601635 ], [ -122.328883, 47.602181 ], [ -122.328862, 47.602312 ], [ -122.328665, 47.602495 ], [ -122.328447, 47.602527 ], [ -122.328113, 47.601715 ], [ -122.328192, 47.601535 ], [ -122.328531, 47.601575 ], [ -122.328583, 47.601635 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32559, 47.596257 ], [ -122.325389, 47.596325 ], [ -122.32474, 47.596019 ], [ -122.324724, 47.595999 ], [ -122.324997, 47.5959 ], [ -122.325591, 47.595779 ], [ -122.32559, 47.596257 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7142857142857143 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329976, 47.599045 ], [ -122.330608, 47.598969 ], [ -122.330606, 47.599534 ], [ -122.330322, 47.599517 ], [ -122.330071, 47.599337 ], [ -122.329976, 47.599085 ], [ -122.329976, 47.599045 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336975, 47.600539 ], [ -122.336971, 47.600543 ], [ -122.335961, 47.60058 ], [ -122.335789, 47.600403 ], [ -122.335779, 47.600168 ], [ -122.335791, 47.600154 ], [ -122.336598, 47.600166 ], [ -122.336975, 47.600539 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329768, 47.602134 ], [ -122.329326, 47.60253 ], [ -122.328862, 47.602312 ], [ -122.328883, 47.602181 ], [ -122.329067, 47.602049 ], [ -122.329421, 47.601818 ], [ -122.329768, 47.602134 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322554, 47.607303 ], [ -122.322625, 47.607471 ], [ -122.322057, 47.607988 ], [ -122.321542, 47.607703 ], [ -122.322172, 47.607145 ], [ -122.322429, 47.607184 ], [ -122.322554, 47.607303 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336985, 47.603046 ], [ -122.336709, 47.602998 ], [ -122.336437, 47.602587 ], [ -122.336325, 47.602302 ], [ -122.336478, 47.602175 ], [ -122.337014, 47.602048 ], [ -122.337054, 47.602061 ], [ -122.33739, 47.602464 ], [ -122.337462, 47.60261 ], [ -122.336985, 47.603046 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328329, 47.596827 ], [ -122.330339, 47.596845 ], [ -122.33033, 47.597007 ], [ -122.330067, 47.597358 ], [ -122.328358, 47.597347 ], [ -122.328243, 47.596898 ], [ -122.328329, 47.596827 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331102, 47.607317 ], [ -122.331385, 47.607255 ], [ -122.331455, 47.607249 ], [ -122.331652, 47.607715 ], [ -122.331369, 47.607982 ], [ -122.331102, 47.607317 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328463, 47.608623 ], [ -122.328425, 47.608608 ], [ -122.328047, 47.607698 ], [ -122.328261, 47.6075 ], [ -122.328457, 47.60748 ], [ -122.328807, 47.608304 ], [ -122.328463, 47.608623 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333346, 47.597269 ], [ -122.334781, 47.597438 ], [ -122.334803, 47.597513 ], [ -122.334584, 47.597988 ], [ -122.334196, 47.598136 ], [ -122.333842, 47.598137 ], [ -122.333403, 47.597415 ], [ -122.333346, 47.597269 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324186, 47.60723 ], [ -122.324014, 47.607376 ], [ -122.32356, 47.607202 ], [ -122.32336, 47.606736 ], [ -122.323374, 47.606657 ], [ -122.323476, 47.606559 ], [ -122.323926, 47.60659 ], [ -122.324186, 47.60723 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331975, 47.604757 ], [ -122.332434, 47.604837 ], [ -122.332431, 47.604983 ], [ -122.331924, 47.60547 ], [ -122.331577, 47.60518 ], [ -122.331614, 47.605102 ], [ -122.331975, 47.604757 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7142857142857143 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324813, 47.604856 ], [ -122.325212, 47.605792 ], [ -122.32497, 47.606016 ], [ -122.32476, 47.606039 ], [ -122.32446, 47.605655 ], [ -122.324316, 47.605308 ], [ -122.324813, 47.604856 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330609, 47.599538 ], [ -122.330697, 47.599625 ], [ -122.330685, 47.59967 ], [ -122.33038, 47.599938 ], [ -122.330158, 47.599936 ], [ -122.330609, 47.599538 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325386, 47.597097 ], [ -122.325383, 47.597099 ], [ -122.324736, 47.597095 ], [ -122.32474, 47.596019 ], [ -122.325389, 47.596325 ], [ -122.325386, 47.597097 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328377, 47.598176 ], [ -122.329763, 47.598149 ], [ -122.329769, 47.598208 ], [ -122.329764, 47.598225 ], [ -122.328975, 47.598663 ], [ -122.328513, 47.598641 ], [ -122.328358, 47.598514 ], [ -122.328377, 47.598176 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.46666666666666667 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322495, 47.608231 ], [ -122.322057, 47.607988 ], [ -122.322625, 47.607471 ], [ -122.322937, 47.607785 ], [ -122.322935, 47.607825 ], [ -122.322495, 47.608231 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325133, 47.608877 ], [ -122.325318, 47.609323 ], [ -122.324996, 47.609257 ], [ -122.324789, 47.609182 ], [ -122.325133, 47.608877 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336307, 47.606911 ], [ -122.336969, 47.606303 ], [ -122.337266, 47.60669 ], [ -122.336485, 47.607407 ], [ -122.336287, 47.607268 ], [ -122.336307, 47.606911 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.054545454545454543 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331917, 47.59782 ], [ -122.331062, 47.597819 ], [ -122.33033, 47.597007 ], [ -122.330339, 47.596845 ], [ -122.3308, 47.595463 ], [ -122.33119, 47.595489 ], [ -122.332517, 47.59576 ], [ -122.332895, 47.596885 ], [ -122.332906, 47.596937 ], [ -122.332571, 47.597387 ], [ -122.331917, 47.59782 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324316, 47.605308 ], [ -122.32446, 47.605655 ], [ -122.324124, 47.605965 ], [ -122.32403, 47.605882 ], [ -122.323852, 47.605455 ], [ -122.32388, 47.60543 ], [ -122.32416, 47.605322 ], [ -122.324316, 47.605308 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323999, 47.607452 ], [ -122.324231, 47.608012 ], [ -122.323973, 47.608213 ], [ -122.32375, 47.607679 ], [ -122.323999, 47.607452 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323195, 47.599656 ], [ -122.32331, 47.599563 ], [ -122.324174, 47.599569 ], [ -122.324197, 47.599606 ], [ -122.324162, 47.599662 ], [ -122.323195, 47.599656 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27272727272727271 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325021, 47.608332 ], [ -122.324938, 47.608125 ], [ -122.325382, 47.607715 ], [ -122.326007, 47.60765 ], [ -122.326043, 47.607664 ], [ -122.326255, 47.60817 ], [ -122.326183, 47.608287 ], [ -122.325824, 47.608619 ], [ -122.325381, 47.608665 ], [ -122.325242, 47.608646 ], [ -122.325021, 47.608332 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320132, 47.603949 ], [ -122.320143, 47.603116 ], [ -122.320353, 47.60308 ], [ -122.320499, 47.603202 ], [ -122.32049, 47.603883 ], [ -122.320401, 47.603958 ], [ -122.320339, 47.603985 ], [ -122.320132, 47.603949 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1388888888888889 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32472, 47.599439 ], [ -122.324584, 47.599608 ], [ -122.324197, 47.599606 ], [ -122.324174, 47.599569 ], [ -122.324086, 47.599389 ], [ -122.324069, 47.5992 ], [ -122.324096, 47.598775 ], [ -122.324722, 47.598779 ], [ -122.32472, 47.599439 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.083333333333333329 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320429, 47.604902 ], [ -122.320427, 47.605587 ], [ -122.320301, 47.605711 ], [ -122.319747, 47.605714 ], [ -122.319743, 47.605712 ], [ -122.319745, 47.604792 ], [ -122.320312, 47.604791 ], [ -122.320359, 47.604821 ], [ -122.320429, 47.604902 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323333, 47.606052 ], [ -122.322904, 47.605795 ], [ -122.323356, 47.605382 ], [ -122.323777, 47.605482 ], [ -122.32366, 47.605752 ], [ -122.323333, 47.606052 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33238, 47.599628 ], [ -122.332153, 47.599632 ], [ -122.332155, 47.598979 ], [ -122.332444, 47.598979 ], [ -122.33238, 47.599628 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3352, 47.601307 ], [ -122.335266, 47.601252 ], [ -122.335422, 47.601281 ], [ -122.335893, 47.601685 ], [ -122.335915, 47.602226 ], [ -122.335577, 47.602381 ], [ -122.335197, 47.602383 ], [ -122.3352, 47.601307 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334502, 47.603015 ], [ -122.335013, 47.602552 ], [ -122.335281, 47.603226 ], [ -122.334776, 47.603684 ], [ -122.334502, 47.603015 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328377, 47.598176 ], [ -122.328296, 47.597955 ], [ -122.32836, 47.597705 ], [ -122.329895, 47.597686 ], [ -122.329763, 47.598149 ], [ -122.328377, 47.598176 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326547, 47.596589 ], [ -122.326826, 47.597104 ], [ -122.326182, 47.5971 ], [ -122.326183, 47.596581 ], [ -122.326547, 47.596589 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33322, 47.599211 ], [ -122.333219, 47.59965 ], [ -122.332896, 47.599912 ], [ -122.332746, 47.599792 ], [ -122.332749, 47.599208 ], [ -122.33322, 47.599211 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328155, 47.603515 ], [ -122.328823, 47.603514 ], [ -122.329079, 47.604134 ], [ -122.329039, 47.604389 ], [ -122.328744, 47.604392 ], [ -122.328385, 47.604072 ], [ -122.328155, 47.603515 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336238, 47.605397 ], [ -122.336067, 47.605351 ], [ -122.335702, 47.604474 ], [ -122.335989, 47.604296 ], [ -122.336376, 47.605226 ], [ -122.336238, 47.605397 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.338946, 47.602086 ], [ -122.339756, 47.602142 ], [ -122.339785, 47.60234 ], [ -122.338944, 47.602334 ], [ -122.338946, 47.602086 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33822, 47.605394 ], [ -122.338475, 47.606013 ], [ -122.338202, 47.606357 ], [ -122.33798, 47.606376 ], [ -122.337669, 47.605631 ], [ -122.337894, 47.605432 ], [ -122.33822, 47.605394 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326007, 47.60765 ], [ -122.325624, 47.60673 ], [ -122.325868, 47.606509 ], [ -122.32597, 47.606505 ], [ -122.326339, 47.607392 ], [ -122.326043, 47.607664 ], [ -122.326007, 47.60765 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329326, 47.60253 ], [ -122.329768, 47.602134 ], [ -122.329895, 47.602156 ], [ -122.330135, 47.602255 ], [ -122.330236, 47.602333 ], [ -122.33027, 47.60242 ], [ -122.329547, 47.603063 ], [ -122.329326, 47.60253 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319318, 47.602166 ], [ -122.319252, 47.603109 ], [ -122.318992, 47.603175 ], [ -122.318987, 47.602157 ], [ -122.319049, 47.602047 ], [ -122.319318, 47.602166 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329515, 47.603187 ], [ -122.329134, 47.603231 ], [ -122.328826, 47.602873 ], [ -122.328665, 47.602495 ], [ -122.328862, 47.602312 ], [ -122.329326, 47.60253 ], [ -122.329547, 47.603063 ], [ -122.329515, 47.603187 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337054, 47.602061 ], [ -122.337423, 47.601725 ], [ -122.337702, 47.601849 ], [ -122.33739, 47.602464 ], [ -122.337054, 47.602061 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328772, 47.60098 ], [ -122.328774, 47.600799 ], [ -122.329211, 47.600798 ], [ -122.32921, 47.601138 ], [ -122.328841, 47.60114 ], [ -122.328772, 47.60098 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327615, 47.607819 ], [ -122.327715, 47.607729 ], [ -122.328047, 47.607698 ], [ -122.328425, 47.608608 ], [ -122.328066, 47.608643 ], [ -122.327918, 47.608539 ], [ -122.327615, 47.607819 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1388888888888889 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329414, 47.601561 ], [ -122.329411, 47.601464 ], [ -122.329435, 47.601313 ], [ -122.329524, 47.601256 ], [ -122.329904, 47.601155 ], [ -122.330092, 47.601448 ], [ -122.329894, 47.601626 ], [ -122.329422, 47.601592 ], [ -122.329414, 47.601561 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330657, 47.602716 ], [ -122.330749, 47.602757 ], [ -122.330916, 47.60316 ], [ -122.330287, 47.60373 ], [ -122.329997, 47.603728 ], [ -122.329761, 47.603504 ], [ -122.330657, 47.602716 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32681, 47.607123 ], [ -122.326339, 47.607392 ], [ -122.32597, 47.606505 ], [ -122.326459, 47.606377 ], [ -122.326503, 47.606387 ], [ -122.32681, 47.607123 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33454, 47.599742 ], [ -122.334657, 47.599631 ], [ -122.335249, 47.59965 ], [ -122.335251, 47.600143 ], [ -122.335186, 47.600383 ], [ -122.335135, 47.600471 ], [ -122.334542, 47.600473 ], [ -122.33454, 47.599742 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326533, 47.605129 ], [ -122.326558, 47.605139 ], [ -122.326949, 47.606064 ], [ -122.326919, 47.606093 ], [ -122.326503, 47.606387 ], [ -122.326459, 47.606377 ], [ -122.326098, 47.605523 ], [ -122.326533, 47.605129 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334998, 47.604124 ], [ -122.335019, 47.604136 ], [ -122.335228, 47.60448 ], [ -122.335189, 47.604593 ], [ -122.334745, 47.605 ], [ -122.334316, 47.604984 ], [ -122.334291, 47.604773 ], [ -122.334998, 47.604124 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7142857142857143 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323296, 47.607443 ], [ -122.323081, 47.607732 ], [ -122.322937, 47.607785 ], [ -122.322625, 47.607471 ], [ -122.322554, 47.607303 ], [ -122.323104, 47.606971 ], [ -122.323296, 47.607443 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328826, 47.602873 ], [ -122.329134, 47.603231 ], [ -122.328823, 47.603514 ], [ -122.328155, 47.603515 ], [ -122.328128, 47.603499 ], [ -122.328826, 47.602873 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32375, 47.607679 ], [ -122.323973, 47.608213 ], [ -122.3238, 47.608395 ], [ -122.323551, 47.6078 ], [ -122.32375, 47.607679 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328744, 47.604392 ], [ -122.329039, 47.604389 ], [ -122.329266, 47.604615 ], [ -122.328502, 47.605298 ], [ -122.328289, 47.604798 ], [ -122.328744, 47.604392 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5357142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33572, 47.603502 ], [ -122.335753, 47.6035 ], [ -122.336066, 47.604225 ], [ -122.335989, 47.604296 ], [ -122.335702, 47.604474 ], [ -122.335228, 47.60448 ], [ -122.335019, 47.604136 ], [ -122.33572, 47.603502 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324086, 47.597093 ], [ -122.324733, 47.597097 ], [ -122.324731, 47.597725 ], [ -122.324081, 47.597732 ], [ -122.324083, 47.597095 ], [ -122.324086, 47.597093 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330705, 47.601304 ], [ -122.330558, 47.601056 ], [ -122.330561, 47.600687 ], [ -122.330873, 47.600639 ], [ -122.33087, 47.601306 ], [ -122.330705, 47.601304 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335254, 47.598088 ], [ -122.335715, 47.598099 ], [ -122.335744, 47.598382 ], [ -122.335675, 47.598456 ], [ -122.335273, 47.598473 ], [ -122.335254, 47.598088 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321021, 47.604405 ], [ -122.32088, 47.603878 ], [ -122.321266, 47.603649 ], [ -122.321506, 47.604203 ], [ -122.321527, 47.604415 ], [ -122.32136, 47.604576 ], [ -122.321266, 47.604585 ], [ -122.321021, 47.604405 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337423, 47.601725 ], [ -122.33742, 47.600437 ], [ -122.337785, 47.60027 ], [ -122.337788, 47.60184 ], [ -122.337702, 47.601849 ], [ -122.337423, 47.601725 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3349, 47.597224 ], [ -122.334485, 47.596569 ], [ -122.334486, 47.596363 ], [ -122.335055, 47.596568 ], [ -122.335131, 47.596611 ], [ -122.33513, 47.596938 ], [ -122.335022, 47.597128 ], [ -122.3349, 47.597224 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328695, 47.596009 ], [ -122.329076, 47.595352 ], [ -122.329099, 47.59535 ], [ -122.3308, 47.595463 ], [ -122.330339, 47.596845 ], [ -122.328329, 47.596827 ], [ -122.328695, 47.596009 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327618, 47.602835 ], [ -122.327287, 47.602417 ], [ -122.327268, 47.602312 ], [ -122.327363, 47.602168 ], [ -122.327896, 47.601936 ], [ -122.328194, 47.602661 ], [ -122.327886, 47.602944 ], [ -122.327618, 47.602835 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327364, 47.59584 ], [ -122.327556, 47.595453 ], [ -122.328079, 47.595418 ], [ -122.327877, 47.596006 ], [ -122.327865, 47.596025 ], [ -122.327382, 47.595985 ], [ -122.327366, 47.595897 ], [ -122.327364, 47.59584 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.19444444444444445 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329997, 47.603728 ], [ -122.329937, 47.603986 ], [ -122.329267, 47.604616 ], [ -122.329266, 47.604615 ], [ -122.329039, 47.604389 ], [ -122.329079, 47.604134 ], [ -122.329754, 47.6035 ], [ -122.329761, 47.603504 ], [ -122.329997, 47.603728 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336478, 47.602175 ], [ -122.336325, 47.602302 ], [ -122.335915, 47.602226 ], [ -122.335893, 47.601685 ], [ -122.336452, 47.601165 ], [ -122.336472, 47.601157 ], [ -122.336478, 47.602175 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3332, 47.601311 ], [ -122.3332, 47.60131 ], [ -122.333203, 47.60047 ], [ -122.333833, 47.600474 ], [ -122.333834, 47.601141 ], [ -122.333697, 47.601304 ], [ -122.333566, 47.601313 ], [ -122.3332, 47.601311 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1388888888888889 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322866, 47.598729 ], [ -122.3232, 47.598762 ], [ -122.323191, 47.599658 ], [ -122.323091, 47.59978 ], [ -122.322904, 47.599955 ], [ -122.322832, 47.600011 ], [ -122.322731, 47.599105 ], [ -122.322771, 47.598926 ], [ -122.322866, 47.598729 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.38095238095238093 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331614, 47.605102 ], [ -122.331577, 47.60518 ], [ -122.331263, 47.605288 ], [ -122.330937, 47.604991 ], [ -122.330784, 47.604616 ], [ -122.331369, 47.604503 ], [ -122.331614, 47.605102 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326707, 47.601873 ], [ -122.326028, 47.601975 ], [ -122.32603, 47.601294 ], [ -122.326691, 47.601304 ], [ -122.326708, 47.601318 ], [ -122.326707, 47.601873 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330356, 47.605646 ], [ -122.330222, 47.605762 ], [ -122.330074, 47.605796 ], [ -122.329723, 47.604941 ], [ -122.330154, 47.605 ], [ -122.330363, 47.60551 ], [ -122.330356, 47.605646 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335534, 47.607509 ], [ -122.335809, 47.608172 ], [ -122.335289, 47.60846 ], [ -122.334985, 47.607727 ], [ -122.335201, 47.607537 ], [ -122.335534, 47.607509 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324341, 47.604064 ], [ -122.323689, 47.60367 ], [ -122.323689, 47.603663 ], [ -122.325104, 47.602526 ], [ -122.325423, 47.60274 ], [ -122.324341, 47.604064 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.338542, 47.605104 ], [ -122.338917, 47.60517 ], [ -122.338996, 47.605355 ], [ -122.338475, 47.606013 ], [ -122.33822, 47.605394 ], [ -122.338542, 47.605104 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331822, 47.59945 ], [ -122.331253, 47.599457 ], [ -122.331255, 47.598748 ], [ -122.33175, 47.598762 ], [ -122.331824, 47.598867 ], [ -122.331822, 47.59945 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.33046, 47.600582 ], [ -122.330543, 47.600281 ], [ -122.330684, 47.600154 ], [ -122.331248, 47.600406 ], [ -122.331042, 47.600592 ], [ -122.330873, 47.600639 ], [ -122.330561, 47.600687 ], [ -122.33046, 47.600582 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32361, 47.604776 ], [ -122.323315, 47.604594 ], [ -122.32344, 47.603899 ], [ -122.323689, 47.60367 ], [ -122.324341, 47.604064 ], [ -122.324492, 47.604251 ], [ -122.32393, 47.604767 ], [ -122.32361, 47.604776 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331123, 47.599628 ], [ -122.33121, 47.599789 ], [ -122.331257, 47.599964 ], [ -122.331255, 47.600404 ], [ -122.331248, 47.600406 ], [ -122.330684, 47.600154 ], [ -122.330685, 47.59967 ], [ -122.330697, 47.599625 ], [ -122.331123, 47.599628 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335989, 47.604296 ], [ -122.336066, 47.604225 ], [ -122.336397, 47.604212 ], [ -122.336698, 47.604934 ], [ -122.336376, 47.605226 ], [ -122.335989, 47.604296 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337078, 47.604301 ], [ -122.336702, 47.604001 ], [ -122.337197, 47.603551 ], [ -122.337226, 47.603563 ], [ -122.337624, 47.603803 ], [ -122.337078, 47.604301 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334885, 47.606796 ], [ -122.335285, 47.606439 ], [ -122.335672, 47.607383 ], [ -122.335534, 47.607509 ], [ -122.335201, 47.607537 ], [ -122.334885, 47.606796 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329894, 47.601626 ], [ -122.330092, 47.601448 ], [ -122.330135, 47.601472 ], [ -122.330135, 47.602255 ], [ -122.329895, 47.602156 ], [ -122.329894, 47.601626 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.46666666666666667 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320401, 47.603958 ], [ -122.32049, 47.603883 ], [ -122.32088, 47.603878 ], [ -122.321021, 47.604405 ], [ -122.320771, 47.604408 ], [ -122.320401, 47.603958 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324014, 47.607376 ], [ -122.323999, 47.607452 ], [ -122.32375, 47.607679 ], [ -122.323551, 47.6078 ], [ -122.323081, 47.607732 ], [ -122.323296, 47.607443 ], [ -122.32356, 47.607202 ], [ -122.324014, 47.607376 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331455, 47.607249 ], [ -122.331695, 47.60704 ], [ -122.331811, 47.607031 ], [ -122.332177, 47.6079 ], [ -122.332121, 47.607952 ], [ -122.331852, 47.607827 ], [ -122.331652, 47.607715 ], [ -122.331455, 47.607249 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329764, 47.598225 ], [ -122.329769, 47.598208 ], [ -122.330725, 47.598758 ], [ -122.330608, 47.598969 ], [ -122.329976, 47.599045 ], [ -122.329719, 47.598679 ], [ -122.329764, 47.598225 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335942, 47.598851 ], [ -122.335675, 47.598456 ], [ -122.335744, 47.598382 ], [ -122.336743, 47.59832 ], [ -122.336248, 47.598759 ], [ -122.336105, 47.598843 ], [ -122.335942, 47.598851 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335784, 47.599496 ], [ -122.335452, 47.59963 ], [ -122.335273, 47.599627 ], [ -122.33527, 47.599153 ], [ -122.335337, 47.598945 ], [ -122.335781, 47.598918 ], [ -122.335784, 47.599496 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336598, 47.600166 ], [ -122.335791, 47.600154 ], [ -122.335789, 47.599916 ], [ -122.336391, 47.599886 ], [ -122.336598, 47.600166 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5357142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327403, 47.606979 ], [ -122.327606, 47.606793 ], [ -122.327768, 47.606775 ], [ -122.328104, 47.60713 ], [ -122.328261, 47.6075 ], [ -122.328047, 47.607698 ], [ -122.327715, 47.607729 ], [ -122.327403, 47.606979 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331123, 47.599628 ], [ -122.331253, 47.599457 ], [ -122.331822, 47.59945 ], [ -122.332023, 47.599659 ], [ -122.331961, 47.599779 ], [ -122.33121, 47.599789 ], [ -122.331123, 47.599628 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335047, 47.602464 ], [ -122.33475, 47.60226 ], [ -122.334542, 47.601934 ], [ -122.334543, 47.601458 ], [ -122.334608, 47.601319 ], [ -122.3352, 47.601307 ], [ -122.335197, 47.602383 ], [ -122.335047, 47.602464 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323426, 47.597936 ], [ -122.322781, 47.597939 ], [ -122.322779, 47.597937 ], [ -122.322782, 47.597089 ], [ -122.323246, 47.597092 ], [ -122.323429, 47.59715 ], [ -122.323426, 47.597936 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.054545454545454543 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331913, 47.600464 ], [ -122.331915, 47.599956 ], [ -122.331961, 47.599779 ], [ -122.332023, 47.599659 ], [ -122.332153, 47.599632 ], [ -122.33238, 47.599628 ], [ -122.332746, 47.599792 ], [ -122.332896, 47.599912 ], [ -122.332895, 47.600221 ], [ -122.332555, 47.600471 ], [ -122.331913, 47.600464 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327996, 47.601299 ], [ -122.327992, 47.600797 ], [ -122.328072, 47.600454 ], [ -122.328433, 47.600456 ], [ -122.328425, 47.600985 ], [ -122.328064, 47.601353 ], [ -122.327996, 47.601299 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321832, 47.606782 ], [ -122.322172, 47.607145 ], [ -122.321542, 47.607703 ], [ -122.321518, 47.60769 ], [ -122.321172, 47.607406 ], [ -122.321832, 47.606782 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332525, 47.605211 ], [ -122.332787, 47.605623 ], [ -122.332436, 47.605935 ], [ -122.332069, 47.605883 ], [ -122.332008, 47.605668 ], [ -122.332525, 47.605211 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325242, 47.608646 ], [ -122.325381, 47.608665 ], [ -122.325686, 47.609398 ], [ -122.325318, 47.609323 ], [ -122.325133, 47.608877 ], [ -122.325242, 47.608646 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324089, 47.596228 ], [ -122.324724, 47.595999 ], [ -122.32474, 47.596019 ], [ -122.324736, 47.597095 ], [ -122.324733, 47.597097 ], [ -122.324086, 47.597093 ], [ -122.324089, 47.596228 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327352, 47.601287 ], [ -122.327344, 47.600804 ], [ -122.327992, 47.600797 ], [ -122.327996, 47.601299 ], [ -122.327358, 47.601291 ], [ -122.327352, 47.601287 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332544, 47.601315 ], [ -122.332101, 47.601305 ], [ -122.331901, 47.601243 ], [ -122.331905, 47.600471 ], [ -122.331913, 47.600464 ], [ -122.332555, 47.600471 ], [ -122.332551, 47.60131 ], [ -122.332544, 47.601315 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326909, 47.597131 ], [ -122.327033, 47.597208 ], [ -122.327032, 47.597696 ], [ -122.326708, 47.597949 ], [ -122.326048, 47.597945 ], [ -122.32605, 47.597162 ], [ -122.326182, 47.5971 ], [ -122.326826, 47.597104 ], [ -122.326909, 47.597131 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1388888888888889 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331236, 47.605375 ], [ -122.331263, 47.605288 ], [ -122.331577, 47.60518 ], [ -122.331924, 47.60547 ], [ -122.332008, 47.605668 ], [ -122.332069, 47.605883 ], [ -122.331951, 47.60598 ], [ -122.331485, 47.605956 ], [ -122.331236, 47.605375 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333072, 47.598523 ], [ -122.333077, 47.59709 ], [ -122.333346, 47.597269 ], [ -122.333403, 47.597415 ], [ -122.3334, 47.598533 ], [ -122.333227, 47.59865 ], [ -122.333072, 47.598523 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323428, 47.597937 ], [ -122.323426, 47.598692 ], [ -122.3232, 47.598762 ], [ -122.322866, 47.598729 ], [ -122.322779, 47.598608 ], [ -122.322781, 47.597939 ], [ -122.323426, 47.597936 ], [ -122.323428, 47.597937 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332074, 47.602253 ], [ -122.331945, 47.602199 ], [ -122.332306, 47.601856 ], [ -122.332489, 47.601872 ], [ -122.332074, 47.602253 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321459, 47.602437 ], [ -122.321151, 47.602199 ], [ -122.321158, 47.601358 ], [ -122.321351, 47.601279 ], [ -122.321542, 47.601272 ], [ -122.322015, 47.601366 ], [ -122.322018, 47.601945 ], [ -122.321895, 47.602179 ], [ -122.321459, 47.602437 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.083333333333333329 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333833, 47.600474 ], [ -122.333203, 47.60047 ], [ -122.332895, 47.600221 ], [ -122.332896, 47.599912 ], [ -122.333219, 47.59965 ], [ -122.333699, 47.599654 ], [ -122.333839, 47.599699 ], [ -122.333837, 47.600471 ], [ -122.333833, 47.600474 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321106, 47.606346 ], [ -122.321118, 47.606079 ], [ -122.321306, 47.605663 ], [ -122.3218, 47.606158 ], [ -122.32184, 47.606404 ], [ -122.321826, 47.606435 ], [ -122.321184, 47.60639 ], [ -122.321106, 47.606346 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.338226, 47.602022 ], [ -122.338408, 47.601737 ], [ -122.338914, 47.601912 ], [ -122.338946, 47.602086 ], [ -122.338944, 47.602334 ], [ -122.338615, 47.6027 ], [ -122.338205, 47.602402 ], [ -122.338226, 47.602022 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329894, 47.601626 ], [ -122.329895, 47.602156 ], [ -122.329768, 47.602134 ], [ -122.329421, 47.601818 ], [ -122.329422, 47.601592 ], [ -122.329894, 47.601626 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322282, 47.600131 ], [ -122.321632, 47.600759 ], [ -122.321367, 47.600759 ], [ -122.321167, 47.599969 ], [ -122.321497, 47.599861 ], [ -122.322196, 47.600077 ], [ -122.322282, 47.600131 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326934, 47.608154 ], [ -122.327151, 47.607958 ], [ -122.327335, 47.607945 ], [ -122.327553, 47.608461 ], [ -122.327198, 47.608787 ], [ -122.326934, 47.608154 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329379, 47.599764 ], [ -122.329377, 47.600424 ], [ -122.32937, 47.600426 ], [ -122.329067, 47.600376 ], [ -122.329068, 47.599995 ], [ -122.329222, 47.599807 ], [ -122.329379, 47.599764 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.26666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326813, 47.607124 ], [ -122.32681, 47.607123 ], [ -122.326503, 47.606387 ], [ -122.326919, 47.606093 ], [ -122.327292, 47.606993 ], [ -122.326813, 47.607124 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.8 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327896, 47.601936 ], [ -122.328113, 47.601715 ], [ -122.328447, 47.602527 ], [ -122.328194, 47.602661 ], [ -122.327896, 47.601936 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321266, 47.604585 ], [ -122.32136, 47.604576 ], [ -122.321665, 47.605315 ], [ -122.321303, 47.605645 ], [ -122.321167, 47.60558 ], [ -122.320921, 47.604903 ], [ -122.321266, 47.604585 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333842, 47.598137 ], [ -122.333841, 47.598535 ], [ -122.33384, 47.598536 ], [ -122.3334, 47.598533 ], [ -122.333403, 47.597415 ], [ -122.333842, 47.598137 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325824, 47.608619 ], [ -122.326027, 47.609106 ], [ -122.325699, 47.609401 ], [ -122.325686, 47.609398 ], [ -122.325381, 47.608665 ], [ -122.325824, 47.608619 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321184, 47.60639 ], [ -122.321826, 47.606435 ], [ -122.321812, 47.606736 ], [ -122.32135, 47.60677 ], [ -122.321184, 47.60639 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328705, 47.599457 ], [ -122.328727, 47.599229 ], [ -122.329099, 47.599232 ], [ -122.329179, 47.59946 ], [ -122.328705, 47.599457 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329904, 47.601155 ], [ -122.329961, 47.601049 ], [ -122.330558, 47.601056 ], [ -122.330705, 47.601304 ], [ -122.330555, 47.60147 ], [ -122.330135, 47.601472 ], [ -122.330092, 47.601448 ], [ -122.329904, 47.601155 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333651, 47.604276 ], [ -122.333498, 47.604413 ], [ -122.333157, 47.604452 ], [ -122.332837, 47.603709 ], [ -122.333005, 47.603551 ], [ -122.333429, 47.603573 ], [ -122.333637, 47.604055 ], [ -122.333651, 47.604276 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333221, 47.59896 ], [ -122.333748, 47.598961 ], [ -122.333673, 47.599212 ], [ -122.333222, 47.599201 ], [ -122.333221, 47.59896 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.338779, 47.59953 ], [ -122.339003, 47.599812 ], [ -122.339424, 47.600748 ], [ -122.338931, 47.601902 ], [ -122.338914, 47.601912 ], [ -122.338408, 47.601737 ], [ -122.33841, 47.599913 ], [ -122.338779, 47.59953 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331721, 47.604168 ], [ -122.331975, 47.604757 ], [ -122.331614, 47.605102 ], [ -122.331369, 47.604503 ], [ -122.331721, 47.604168 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336075, 47.599489 ], [ -122.335784, 47.599496 ], [ -122.335781, 47.598918 ], [ -122.335942, 47.598851 ], [ -122.336105, 47.598843 ], [ -122.336075, 47.599489 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335871, 47.603117 ], [ -122.336437, 47.602587 ], [ -122.336709, 47.602998 ], [ -122.336335, 47.603349 ], [ -122.335893, 47.603371 ], [ -122.335871, 47.603117 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319745, 47.604792 ], [ -122.31974, 47.604788 ], [ -122.319741, 47.603949 ], [ -122.320132, 47.603949 ], [ -122.320339, 47.603985 ], [ -122.320312, 47.604791 ], [ -122.319745, 47.604792 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324799, 47.608114 ], [ -122.324886, 47.608104 ], [ -122.324938, 47.608125 ], [ -122.325021, 47.608332 ], [ -122.324273, 47.608996 ], [ -122.323947, 47.608879 ], [ -122.324799, 47.608114 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327997, 47.599839 ], [ -122.327995, 47.60038 ], [ -122.327348, 47.600376 ], [ -122.32735, 47.599901 ], [ -122.327377, 47.599835 ], [ -122.327997, 47.599839 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323713, 47.608609 ], [ -122.323476, 47.608709 ], [ -122.323143, 47.608589 ], [ -122.323008, 47.608514 ], [ -122.322949, 47.608376 ], [ -122.323047, 47.608104 ], [ -122.323713, 47.608609 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326548, 47.595674 ], [ -122.32649, 47.595595 ], [ -122.326864, 47.595519 ], [ -122.326906, 47.595565 ], [ -122.326833, 47.595728 ], [ -122.326548, 47.595674 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321542, 47.601272 ], [ -122.321351, 47.601279 ], [ -122.321357, 47.600795 ], [ -122.321367, 47.600759 ], [ -122.321632, 47.600759 ], [ -122.321542, 47.601272 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330154, 47.605 ], [ -122.329723, 47.604941 ], [ -122.32955, 47.604888 ], [ -122.330099, 47.604379 ], [ -122.330564, 47.604621 ], [ -122.330154, 47.605 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336698, 47.604934 ], [ -122.337028, 47.604917 ], [ -122.337338, 47.605654 ], [ -122.336874, 47.606075 ], [ -122.336455, 47.605913 ], [ -122.336238, 47.605397 ], [ -122.336376, 47.605226 ], [ -122.336698, 47.604934 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328099, 47.606475 ], [ -122.328529, 47.606475 ], [ -122.32855, 47.606718 ], [ -122.328104, 47.60713 ], [ -122.327768, 47.606775 ], [ -122.328099, 47.606475 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334276, 47.608125 ], [ -122.333885, 47.607175 ], [ -122.334005, 47.607064 ], [ -122.334069, 47.607056 ], [ -122.334458, 47.607956 ], [ -122.334276, 47.608125 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320921, 47.604903 ], [ -122.321167, 47.60558 ], [ -122.320427, 47.605587 ], [ -122.320429, 47.604902 ], [ -122.320921, 47.604903 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327496, 47.598986 ], [ -122.327323, 47.598898 ], [ -122.327243, 47.598756 ], [ -122.32736, 47.598572 ], [ -122.328287, 47.598579 ], [ -122.328223, 47.598692 ], [ -122.327842, 47.598988 ], [ -122.327496, 47.598986 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.38095238095238093 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331052, 47.601204 ], [ -122.331042, 47.600592 ], [ -122.331248, 47.600406 ], [ -122.331255, 47.600404 ], [ -122.33138, 47.600462 ], [ -122.331378, 47.600913 ], [ -122.331052, 47.601204 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326994, 47.596215 ], [ -122.327322, 47.597024 ], [ -122.327033, 47.597208 ], [ -122.326909, 47.597131 ], [ -122.326847, 47.596221 ], [ -122.326994, 47.596215 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333227, 47.59865 ], [ -122.3334, 47.598533 ], [ -122.33384, 47.598536 ], [ -122.333841, 47.598887 ], [ -122.333826, 47.598921 ], [ -122.333748, 47.598961 ], [ -122.333221, 47.59896 ], [ -122.333216, 47.598953 ], [ -122.333227, 47.59865 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.027777777777777776 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.337538, 47.602622 ], [ -122.337462, 47.60261 ], [ -122.33739, 47.602464 ], [ -122.337702, 47.601849 ], [ -122.337788, 47.60184 ], [ -122.338226, 47.602022 ], [ -122.338205, 47.602402 ], [ -122.337894, 47.602541 ], [ -122.337538, 47.602622 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320301, 47.605711 ], [ -122.320427, 47.605587 ], [ -122.321167, 47.60558 ], [ -122.321303, 47.605645 ], [ -122.321306, 47.605663 ], [ -122.321118, 47.606079 ], [ -122.320435, 47.606085 ], [ -122.320301, 47.605711 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322653, 47.600293 ], [ -122.322796, 47.60063 ], [ -122.322015, 47.601366 ], [ -122.321542, 47.601272 ], [ -122.321632, 47.600759 ], [ -122.322282, 47.600131 ], [ -122.322653, 47.600293 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331912, 47.606216 ], [ -122.332186, 47.606871 ], [ -122.332114, 47.606935 ], [ -122.331811, 47.607031 ], [ -122.331695, 47.60704 ], [ -122.331505, 47.606585 ], [ -122.331912, 47.606216 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.338653, 47.603405 ], [ -122.33902, 47.603784 ], [ -122.338284, 47.604451 ], [ -122.337892, 47.604385 ], [ -122.337653, 47.603812 ], [ -122.338029, 47.603469 ], [ -122.338144, 47.603437 ], [ -122.338653, 47.603405 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328669, 47.599994 ], [ -122.329068, 47.599995 ], [ -122.329067, 47.600376 ], [ -122.328668, 47.600373 ], [ -122.328669, 47.599994 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324886, 47.608104 ], [ -122.32451, 47.607201 ], [ -122.324736, 47.606998 ], [ -122.325069, 47.606965 ], [ -122.325382, 47.607715 ], [ -122.324938, 47.608125 ], [ -122.324886, 47.608104 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329754, 47.6035 ], [ -122.329515, 47.603187 ], [ -122.329547, 47.603063 ], [ -122.33027, 47.60242 ], [ -122.330657, 47.602716 ], [ -122.329761, 47.603504 ], [ -122.329754, 47.6035 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.329068, 47.599995 ], [ -122.328669, 47.599994 ], [ -122.328645, 47.599803 ], [ -122.329222, 47.599807 ], [ -122.329068, 47.599995 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.336048, 47.606287 ], [ -122.336307, 47.606911 ], [ -122.336287, 47.607268 ], [ -122.336013, 47.607267 ], [ -122.335642, 47.606375 ], [ -122.336048, 47.606287 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335189, 47.604593 ], [ -122.335228, 47.60448 ], [ -122.335702, 47.604474 ], [ -122.336067, 47.605351 ], [ -122.335781, 47.605399 ], [ -122.335397, 47.605092 ], [ -122.335189, 47.604593 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322216, 47.605777 ], [ -122.3218, 47.606158 ], [ -122.321306, 47.605663 ], [ -122.321303, 47.605645 ], [ -122.321665, 47.605315 ], [ -122.32201, 47.605286 ], [ -122.322216, 47.605777 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318559, 47.601348 ], [ -122.318562, 47.601324 ], [ -122.319994, 47.600841 ], [ -122.320138, 47.601326 ], [ -122.318772, 47.601541 ], [ -122.318559, 47.601348 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332566, 47.598889 ], [ -122.332562, 47.598526 ], [ -122.332567, 47.598518 ], [ -122.333072, 47.598523 ], [ -122.333227, 47.59865 ], [ -122.333216, 47.598953 ], [ -122.332674, 47.59895 ], [ -122.332566, 47.598889 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332566, 47.598889 ], [ -122.332444, 47.598979 ], [ -122.332155, 47.598979 ], [ -122.331824, 47.598867 ], [ -122.33175, 47.598762 ], [ -122.331915, 47.598523 ], [ -122.332562, 47.598526 ], [ -122.332566, 47.598889 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.338144, 47.603437 ], [ -122.338029, 47.603469 ], [ -122.337725, 47.603097 ], [ -122.337538, 47.602622 ], [ -122.337894, 47.602541 ], [ -122.338144, 47.603437 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5357142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328113, 47.601715 ], [ -122.327896, 47.601936 ], [ -122.327363, 47.602168 ], [ -122.327358, 47.601291 ], [ -122.327996, 47.601299 ], [ -122.328064, 47.601353 ], [ -122.328192, 47.601535 ], [ -122.328113, 47.601715 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327344, 47.600804 ], [ -122.327254, 47.600463 ], [ -122.327348, 47.600376 ], [ -122.327995, 47.60038 ], [ -122.328072, 47.600454 ], [ -122.327992, 47.600797 ], [ -122.327344, 47.600804 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332191, 47.602994 ], [ -122.332495, 47.603745 ], [ -122.332279, 47.603941 ], [ -122.33181, 47.603988 ], [ -122.331536, 47.603316 ], [ -122.331847, 47.603033 ], [ -122.332191, 47.602994 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320312, 47.604791 ], [ -122.320339, 47.603985 ], [ -122.320401, 47.603958 ], [ -122.320771, 47.604408 ], [ -122.320359, 47.604821 ], [ -122.320312, 47.604791 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.335112, 47.597829 ], [ -122.336301, 47.597757 ], [ -122.335715, 47.598099 ], [ -122.335254, 47.598088 ], [ -122.335112, 47.597829 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.332764, 47.606584 ], [ -122.333113, 47.607424 ], [ -122.332748, 47.60729 ], [ -122.332528, 47.606768 ], [ -122.332708, 47.606584 ], [ -122.332764, 47.606584 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324715, 47.604413 ], [ -122.324492, 47.604251 ], [ -122.324341, 47.604064 ], [ -122.325423, 47.60274 ], [ -122.325543, 47.602786 ], [ -122.325673, 47.602907 ], [ -122.325945, 47.603293 ], [ -122.324715, 47.604413 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331652, 47.607715 ], [ -122.331852, 47.607827 ], [ -122.331337, 47.608306 ], [ -122.331179, 47.608284 ], [ -122.331369, 47.607982 ], [ -122.331652, 47.607715 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334468, 47.605878 ], [ -122.334245, 47.606087 ], [ -122.333743, 47.606133 ], [ -122.333517, 47.605975 ], [ -122.33336, 47.605592 ], [ -122.333372, 47.605567 ], [ -122.33381, 47.605175 ], [ -122.334152, 47.60514 ], [ -122.334468, 47.605878 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327268, 47.602312 ], [ -122.32685, 47.602095 ], [ -122.326707, 47.601873 ], [ -122.326708, 47.601318 ], [ -122.327352, 47.601287 ], [ -122.327358, 47.601291 ], [ -122.327363, 47.602168 ], [ -122.327268, 47.602312 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.41666666666666669 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334687, 47.607767 ], [ -122.334985, 47.607727 ], [ -122.335289, 47.60846 ], [ -122.335056, 47.608589 ], [ -122.334468, 47.608801 ], [ -122.334226, 47.608216 ], [ -122.334276, 47.608125 ], [ -122.334458, 47.607956 ], [ -122.334687, 47.607767 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.334183, 47.600473 ], [ -122.334186, 47.600473 ], [ -122.334537, 47.600476 ], [ -122.334538, 47.601219 ], [ -122.334184, 47.601142 ], [ -122.334183, 47.600473 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.330359, 47.600022 ], [ -122.330359, 47.600161 ], [ -122.329959, 47.60016 ], [ -122.329959, 47.600031 ], [ -122.330359, 47.600022 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32497, 47.606016 ], [ -122.325284, 47.606767 ], [ -122.325069, 47.606965 ], [ -122.324736, 47.606998 ], [ -122.324448, 47.606327 ], [ -122.32476, 47.606039 ], [ -122.32497, 47.606016 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319378, 47.60479 ], [ -122.319373, 47.604791 ], [ -122.31894, 47.60478 ], [ -122.318584, 47.603989 ], [ -122.318577, 47.60394 ], [ -122.319381, 47.603955 ], [ -122.319378, 47.60479 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.338029, 47.603469 ], [ -122.337653, 47.603812 ], [ -122.337624, 47.603803 ], [ -122.337226, 47.603563 ], [ -122.337725, 47.603097 ], [ -122.338029, 47.603469 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333232, 47.607483 ], [ -122.33323, 47.607492 ], [ -122.332758, 47.60792 ], [ -122.332355, 47.607797 ], [ -122.332396, 47.607607 ], [ -122.332748, 47.60729 ], [ -122.333113, 47.607424 ], [ -122.333232, 47.607483 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.331951, 47.60598 ], [ -122.332069, 47.605883 ], [ -122.332436, 47.605935 ], [ -122.332708, 47.606584 ], [ -122.332528, 47.606768 ], [ -122.332186, 47.606871 ], [ -122.331912, 47.606216 ], [ -122.331951, 47.60598 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325948, 47.596234 ], [ -122.326064, 47.59601 ], [ -122.326547, 47.596011 ], [ -122.326718, 47.596173 ], [ -122.326579, 47.596311 ], [ -122.326035, 47.596304 ], [ -122.325948, 47.596234 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32921, 47.601138 ], [ -122.329211, 47.600798 ], [ -122.32937, 47.600426 ], [ -122.329377, 47.600424 ], [ -122.329528, 47.600464 ], [ -122.329524, 47.601256 ], [ -122.329435, 47.601313 ], [ -122.32921, 47.601138 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333572, 47.602272 ], [ -122.333293, 47.602536 ], [ -122.333189, 47.602548 ], [ -122.332805, 47.602226 ], [ -122.332728, 47.602042 ], [ -122.333198, 47.601773 ], [ -122.333563, 47.602259 ], [ -122.333572, 47.602272 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.035714285714285712 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326676, 47.599508 ], [ -122.327232, 47.599512 ], [ -122.327329, 47.599588 ], [ -122.327377, 47.599835 ], [ -122.32735, 47.599901 ], [ -122.326696, 47.599897 ], [ -122.326584, 47.599614 ], [ -122.326676, 47.599508 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318772, 47.601541 ], [ -122.320138, 47.601326 ], [ -122.320173, 47.601367 ], [ -122.320168, 47.602029 ], [ -122.319748, 47.602231 ], [ -122.319318, 47.602166 ], [ -122.319049, 47.602047 ], [ -122.318772, 47.601541 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333517, 47.605975 ], [ -122.333743, 47.606133 ], [ -122.333741, 47.606436 ], [ -122.333271, 47.606874 ], [ -122.332878, 47.606573 ], [ -122.333517, 47.605975 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333216, 47.598953 ], [ -122.333221, 47.59896 ], [ -122.333222, 47.599201 ], [ -122.33322, 47.599211 ], [ -122.332749, 47.599208 ], [ -122.332674, 47.59895 ], [ -122.333216, 47.598953 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328727, 47.599229 ], [ -122.328728, 47.599035 ], [ -122.329099, 47.599043 ], [ -122.329099, 47.599232 ], [ -122.328727, 47.599229 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.333335, 47.608416 ], [ -122.333536, 47.608234 ], [ -122.333961, 47.608187 ], [ -122.334226, 47.608216 ], [ -122.334468, 47.608801 ], [ -122.333624, 47.609105 ], [ -122.333335, 47.608416 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.328121, 47.599635 ], [ -122.327997, 47.599839 ], [ -122.327377, 47.599835 ], [ -122.327329, 47.599588 ], [ -122.327597, 47.599419 ], [ -122.327841, 47.599421 ], [ -122.328121, 47.599635 ] ] ] ] } } +] +} diff --git a/tests/xnqm/outputs/p14_scores.geojson b/tests/xnqm/outputs/p14_scores.geojson new file mode 100644 index 0000000..deafb90 --- /dev/null +++ b/tests/xnqm/outputs/p14_scores.geojson @@ -0,0 +1,273 @@ +{ +"type": "FeatureCollection", +"crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:OGC:1.3:CRS84" } }, +"features": [ +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327642626353523, 47.604679867766357 ], [ -122.327489919920495, 47.604318576852862 ], [ -122.327646614497056, 47.603883132891781 ], [ -122.328452544933072, 47.603174665361514 ], [ -122.328464143265975, 47.603173690234499 ], [ -122.327844945226602, 47.604757026765547 ], [ -122.327642626353523, 47.604679867766357 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.32142857142857145 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.328452544933072, 47.603174665361514 ], [ -122.327889902862395, 47.602945737164823 ], [ -122.327354774918959, 47.601644067468058 ], [ -122.328053513526612, 47.601527140026626 ], [ -122.3281455, 47.6017933 ], [ -122.3284939, 47.6030976 ], [ -122.328464143265975, 47.603173690234499 ], [ -122.328452544933072, 47.603174665361514 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.328452544933072, 47.603174665361514 ], [ -122.327646614497056, 47.603883132891781 ], [ -122.326971925972146, 47.603425949322805 ], [ -122.327490279254434, 47.602952113043287 ], [ -122.327889902862395, 47.602945737164823 ], [ -122.328452544933072, 47.603174665361514 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327213459907185, 47.601620779067488 ], [ -122.326729023399224, 47.602296722085441 ], [ -122.325624108277097, 47.602243493168125 ], [ -122.325294988509214, 47.60215356153055 ], [ -122.325384687268013, 47.60182389586425 ], [ -122.325751304557514, 47.601289564547407 ], [ -122.327016526225876, 47.601308878568489 ], [ -122.327213459907185, 47.601620779067488 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.25 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327354774918959, 47.601644067468058 ], [ -122.327213459907185, 47.601620779067488 ], [ -122.327016526225876, 47.601308878568489 ], [ -122.327012674781741, 47.600457644129833 ], [ -122.327389395613096, 47.599879512149357 ], [ -122.3275147, 47.5999681 ], [ -122.328053513526612, 47.601527140026626 ], [ -122.327354774918959, 47.601644067468058 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.26666666666666666 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.326935909083502, 47.605291912697957 ], [ -122.327642626353523, 47.604679867766357 ], [ -122.327844945226602, 47.604757026765547 ], [ -122.327573200000018, 47.605451899999984 ], [ -122.327291272056684, 47.606131537382858 ], [ -122.326935909083502, 47.605291912697957 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327291272056684, 47.606131537382858 ], [ -122.3271836, 47.6063911 ], [ -122.327036497255122, 47.606687486164368 ], [ -122.326072601870166, 47.606323409433251 ], [ -122.325834632091443, 47.605761079728026 ], [ -122.326532653914583, 47.605129086996236 ], [ -122.326935909083502, 47.605291912697957 ], [ -122.327291272056684, 47.606131537382858 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.326971925972146, 47.603425949322805 ], [ -122.326819683163592, 47.603452760490896 ], [ -122.326633159135099, 47.602983720439795 ], [ -122.32675208304039, 47.602364911509426 ], [ -122.327490279254434, 47.602952113043287 ], [ -122.326971925972146, 47.603425949322805 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327489919920495, 47.604318576852862 ], [ -122.326341484167983, 47.604072945742892 ], [ -122.326819683163592, 47.603452760490896 ], [ -122.326971925972146, 47.603425949322805 ], [ -122.327646614497056, 47.603883132891781 ], [ -122.327489919920495, 47.604318576852862 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327889902862395, 47.602945737164823 ], [ -122.327490279254434, 47.602952113043287 ], [ -122.32675208304039, 47.602364911509426 ], [ -122.326729023399224, 47.602296722085441 ], [ -122.327213459907185, 47.601620779067488 ], [ -122.327354774918959, 47.601644067468058 ], [ -122.327889902862395, 47.602945737164823 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.326341484167983, 47.604072945742892 ], [ -122.326299066998857, 47.604091900046122 ], [ -122.325920822679223, 47.60375177423677 ], [ -122.326209664999297, 47.603057722765591 ], [ -122.326633159135099, 47.602983720439795 ], [ -122.326819683163592, 47.603452760490896 ], [ -122.326341484167983, 47.604072945742892 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327642626353523, 47.604679867766357 ], [ -122.326935909083502, 47.605291912697957 ], [ -122.326532653914583, 47.605129086996236 ], [ -122.326225571622956, 47.604395256363574 ], [ -122.326299066998857, 47.604091900046122 ], [ -122.326341484167983, 47.604072945742892 ], [ -122.327489919920495, 47.604318576852862 ], [ -122.327642626353523, 47.604679867766357 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.325383850621165, 47.606947021482078 ], [ -122.326072601870166, 47.606323409433251 ], [ -122.327036497255122, 47.606687486164368 ], [ -122.326549500000013, 47.6076687 ], [ -122.325828479446244, 47.608014053869702 ], [ -122.325383850621165, 47.606947021482078 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.325920822679223, 47.60375177423677 ], [ -122.325015181821456, 47.603344459142619 ], [ -122.325143530136202, 47.602266709066733 ], [ -122.325294988509214, 47.60215356153055 ], [ -122.325624108277097, 47.602243493168125 ], [ -122.326209664999297, 47.603057722765591 ], [ -122.325920822679223, 47.60375177423677 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.26666666666666666 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.325699606072192, 47.599608256637438 ], [ -122.325702081611453, 47.598782849952414 ], [ -122.325727005863087, 47.598742962141039 ], [ -122.3262728, 47.5990901 ], [ -122.327018454682602, 47.599617263870947 ], [ -122.325699606072192, 47.599608256637438 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324390410270894, 47.597943298127689 ], [ -122.323096233333757, 47.597934723363302 ], [ -122.323098835360838, 47.597071384123886 ], [ -122.324413751748978, 47.597907701755076 ], [ -122.324390410270894, 47.597943298127689 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.326532653914583, 47.605129086996236 ], [ -122.325834632091443, 47.605761079728026 ], [ -122.325417735271444, 47.605603064375181 ], [ -122.325126542938108, 47.604919532594636 ], [ -122.326225571622956, 47.604395256363574 ], [ -122.326532653914583, 47.605129086996236 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.326225571622956, 47.604395256363574 ], [ -122.325126542938108, 47.604919532594636 ], [ -122.324885241683816, 47.604790783563558 ], [ -122.324465257979284, 47.603859608620759 ], [ -122.325015181821456, 47.603344459142619 ], [ -122.325920822679223, 47.60375177423677 ], [ -122.326299066998857, 47.604091900046122 ], [ -122.326225571622956, 47.604395256363574 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327016526225876, 47.601308878568489 ], [ -122.325751304557514, 47.601289564547407 ], [ -122.325753551710037, 47.600458526692726 ], [ -122.327012674781741, 47.600457644129833 ], [ -122.327016526225876, 47.601308878568489 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.32675208304039, 47.602364911509426 ], [ -122.326633159135099, 47.602983720439795 ], [ -122.326209664999297, 47.603057722765591 ], [ -122.325624108277097, 47.602243493168125 ], [ -122.326729023399224, 47.602296722085441 ], [ -122.32675208304039, 47.602364911509426 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.327012674781741, 47.600457644129833 ], [ -122.325753551710037, 47.600458526692726 ], [ -122.325694241615864, 47.600373682723138 ], [ -122.325696350946856, 47.599613411426887 ], [ -122.325699606072192, 47.599608256637438 ], [ -122.327018454682602, 47.599617263870947 ], [ -122.327389395613096, 47.599879512149357 ], [ -122.327012674781741, 47.600457644129833 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.26666666666666666 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.325384687268013, 47.60182389586425 ], [ -122.324521970480831, 47.600529456257917 ], [ -122.325694241615864, 47.600373682723138 ], [ -122.325753551710037, 47.600458526692726 ], [ -122.325751304557514, 47.601289564547407 ], [ -122.325384687268013, 47.60182389586425 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.325294988509214, 47.60215356153055 ], [ -122.325143530136202, 47.602266709066733 ], [ -122.324134533395792, 47.601975173891582 ], [ -122.324137607625019, 47.600652836114548 ], [ -122.324376841513853, 47.600479263078263 ], [ -122.324521970480831, 47.600529456257917 ], [ -122.325384687268013, 47.60182389586425 ], [ -122.325294988509214, 47.60215356153055 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.325828479446244, 47.608014053869702 ], [ -122.325300994954787, 47.608266707985294 ], [ -122.324832898971238, 47.608083375425025 ], [ -122.324478568714426, 47.6078188425235 ], [ -122.324300059380121, 47.607389414319556 ], [ -122.324971028626763, 47.606786180836977 ], [ -122.325383850621165, 47.606947021482078 ], [ -122.325828479446244, 47.608014053869702 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.325834632091443, 47.605761079728026 ], [ -122.326072601870166, 47.606323409433251 ], [ -122.325383850621165, 47.606947021482078 ], [ -122.324971028626763, 47.606786180836977 ], [ -122.324735884026822, 47.606232133934512 ], [ -122.325417735271444, 47.605603064375181 ], [ -122.325834632091443, 47.605761079728026 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324735884026822, 47.606232133934512 ], [ -122.324318176775989, 47.606074227989552 ], [ -122.32408677110945, 47.605516122977477 ], [ -122.324885241683816, 47.604790783563558 ], [ -122.325126542938108, 47.604919532594636 ], [ -122.325417735271444, 47.605603064375181 ], [ -122.324735884026822, 47.606232133934512 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.325015181821456, 47.603344459142619 ], [ -122.324465257979284, 47.603859608620759 ], [ -122.323766801840989, 47.603846000293146 ], [ -122.323182599347604, 47.602463418424492 ], [ -122.323363163919183, 47.602204189117899 ], [ -122.324134533395792, 47.601975173891582 ], [ -122.325143530136202, 47.602266709066733 ], [ -122.325015181821456, 47.603344459142619 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324521970480831, 47.600529456257917 ], [ -122.324376841513853, 47.600479263078263 ], [ -122.324378556129531, 47.599859810536856 ], [ -122.324719736436606, 47.599606860892379 ], [ -122.325696350946856, 47.599613411426887 ], [ -122.325694241615864, 47.600373682723138 ], [ -122.324521970480831, 47.600529456257917 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.325699606072192, 47.599608256637438 ], [ -122.325696350946856, 47.599613411426887 ], [ -122.324719736436606, 47.599606860892379 ], [ -122.324722256870288, 47.598776444318524 ], [ -122.325702081611453, 47.598782849952414 ], [ -122.325699606072192, 47.599608256637438 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.325702081611453, 47.598782849952414 ], [ -122.324722256870288, 47.598776444318524 ], [ -122.324388678231472, 47.598520866654958 ], [ -122.324390410270894, 47.597943298127689 ], [ -122.324413751748978, 47.597907701755076 ], [ -122.325727005863087, 47.598742962141039 ], [ -122.325702081611453, 47.598782849952414 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323941594494684, 47.608883063744209 ], [ -122.324832898971238, 47.608083375425025 ], [ -122.325300994954787, 47.608266707985294 ], [ -122.323953807899883, 47.60891198260363 ], [ -122.323941594494684, 47.608883063744209 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324300059380121, 47.607389414319556 ], [ -122.32389062261845, 47.607244183101187 ], [ -122.323651490568864, 47.606670635162871 ], [ -122.324318176775989, 47.606074227989552 ], [ -122.324735884026822, 47.606232133934512 ], [ -122.324971028626763, 47.606786180836977 ], [ -122.324300059380121, 47.607389414319556 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324378556129531, 47.599859810536856 ], [ -122.324108440480117, 47.599639296056864 ], [ -122.324068714764024, 47.599200427671029 ], [ -122.324097224423141, 47.598756388083899 ], [ -122.324388678231472, 47.598520866654958 ], [ -122.324722256870288, 47.598776444318524 ], [ -122.324719736436606, 47.599606860892379 ], [ -122.324378556129531, 47.599859810536856 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324885241683816, 47.604790783563558 ], [ -122.32408677110945, 47.605516122977477 ], [ -122.323668258868167, 47.605353606183002 ], [ -122.323414657931082, 47.604743830397794 ], [ -122.323714247745997, 47.603894194469852 ], [ -122.323766801840989, 47.603846000293146 ], [ -122.324465257979284, 47.603859608620759 ], [ -122.324885241683816, 47.604790783563558 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323663668431607, 47.608540019181724 ], [ -122.32397255766449, 47.608212868394759 ], [ -122.324478568714426, 47.6078188425235 ], [ -122.324832898971238, 47.608083375425025 ], [ -122.323941594494684, 47.608883063744209 ], [ -122.323663668431607, 47.608540019181724 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.322225658625484, 47.609475067364194 ], [ -122.323374369922206, 47.608432673814505 ], [ -122.323663668431607, 47.608540019181724 ], [ -122.323941594494684, 47.608883063744209 ], [ -122.323953807899883, 47.60891198260363 ], [ -122.323559599999982, 47.6091008 ], [ -122.322288578115874, 47.609624517980826 ], [ -122.322225658625484, 47.609475067364194 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324097224423141, 47.598756388083899 ], [ -122.323090724755772, 47.598749590010456 ], [ -122.32309316666624, 47.597939376636695 ], [ -122.323096233333757, 47.597934723363302 ], [ -122.324390410270894, 47.597943298127689 ], [ -122.324388678231472, 47.598520866654958 ], [ -122.324097224423141, 47.598756388083899 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324108440480117, 47.599639296056864 ], [ -122.323594550490853, 47.599635835069996 ], [ -122.323078349436273, 47.599452457539911 ], [ -122.323087312221375, 47.599194787426605 ], [ -122.324068714764024, 47.599200427671029 ], [ -122.324108440480117, 47.599639296056864 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323663668431607, 47.608540019181724 ], [ -122.323374369922206, 47.608432673814505 ], [ -122.323147784799218, 47.607876515002744 ], [ -122.323384619601711, 47.607659977469417 ], [ -122.323657636165109, 47.607457056796328 ], [ -122.32397255766449, 47.608212868394759 ], [ -122.323663668431607, 47.608540019181724 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324478568714426, 47.6078188425235 ], [ -122.32397255766449, 47.608212868394759 ], [ -122.323657636165109, 47.607457056796328 ], [ -122.32389062261845, 47.607244183101187 ], [ -122.324300059380121, 47.607389414319556 ], [ -122.324478568714426, 47.6078188425235 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324378556129531, 47.599859810536856 ], [ -122.324376841513853, 47.600479263078263 ], [ -122.324137607625019, 47.600652836114548 ], [ -122.323591610384341, 47.600623710859814 ], [ -122.323594550490853, 47.599635835069996 ], [ -122.324108440480117, 47.599639296056864 ], [ -122.324378556129531, 47.599859810536856 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324318176775989, 47.606074227989552 ], [ -122.323651490568864, 47.606670635162871 ], [ -122.323199521014374, 47.606512616314873 ], [ -122.322976436674622, 47.605986266461649 ], [ -122.323668258868167, 47.605353606183002 ], [ -122.32408677110945, 47.605516122977477 ], [ -122.324318176775989, 47.606074227989552 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324068714764024, 47.599200427671029 ], [ -122.323087312221375, 47.599194787426605 ], [ -122.323068544036573, 47.598785836894585 ], [ -122.323090724755772, 47.598749590010456 ], [ -122.324097224423141, 47.598756388083899 ], [ -122.324068714764024, 47.599200427671029 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323657636165109, 47.607457056796328 ], [ -122.323384619601711, 47.607659977469417 ], [ -122.32300122569039, 47.606718644524072 ], [ -122.323199521014374, 47.606512616314873 ], [ -122.323651490568864, 47.606670635162871 ], [ -122.32389062261845, 47.607244183101187 ], [ -122.323657636165109, 47.607457056796328 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320919117313196, 47.596530042929253 ], [ -122.320760324383329, 47.597173319970032 ], [ -122.319860662776918, 47.59755048579737 ], [ -122.319456534323862, 47.596010397423328 ], [ -122.320930526317852, 47.59635634557862 ], [ -122.320919117313196, 47.596530042929253 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323096233333757, 47.597934723363302 ], [ -122.32309316666624, 47.597939376636695 ], [ -122.322064494222218, 47.597932561012364 ], [ -122.322069943975762, 47.596623768630074 ], [ -122.3225852, 47.5967447 ], [ -122.323098835360838, 47.597071384123886 ], [ -122.323096233333757, 47.597934723363302 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323087312221375, 47.599194787426605 ], [ -122.323078349436273, 47.599452457539911 ], [ -122.322275844154561, 47.600454925548924 ], [ -122.322022950443895, 47.600459574181123 ], [ -122.321732534328021, 47.599373609867278 ], [ -122.321736861462341, 47.598842802181501 ], [ -122.321811510430493, 47.598777535729269 ], [ -122.323068544036573, 47.598785836894585 ], [ -122.323087312221375, 47.599194787426605 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323090724755772, 47.598749590010456 ], [ -122.323068544036573, 47.598785836894585 ], [ -122.321811510430493, 47.598777535729269 ], [ -122.322027886421125, 47.597965479554851 ], [ -122.322064494222218, 47.597932561012364 ], [ -122.32309316666624, 47.597939376636695 ], [ -122.323090724755772, 47.598749590010456 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.324134533395792, 47.601975173891582 ], [ -122.323363163919183, 47.602204189117899 ], [ -122.322796262018969, 47.60075745939848 ], [ -122.323591610384341, 47.600623710859814 ], [ -122.324137607625019, 47.600652836114548 ], [ -122.324134533395792, 47.601975173891582 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.066666666666666666 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323591610384341, 47.600623710859814 ], [ -122.322796262018969, 47.60075745939848 ], [ -122.322275844154561, 47.600454925548924 ], [ -122.323078349436273, 47.599452457539911 ], [ -122.323594550490853, 47.599635835069996 ], [ -122.323591610384341, 47.600623710859814 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7142857142857143 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323668258868167, 47.605353606183002 ], [ -122.322976436674622, 47.605986266461649 ], [ -122.322556125783208, 47.605816209151087 ], [ -122.322327740543543, 47.605270958137304 ], [ -122.32274281297542, 47.604889368599771 ], [ -122.323414657931082, 47.604743830397794 ], [ -122.323668258868167, 47.605353606183002 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.32300122569039, 47.606718644524072 ], [ -122.322491573412634, 47.607155189220336 ], [ -122.322096215230474, 47.60700446812411 ], [ -122.321862415293936, 47.606449117497021 ], [ -122.322556125783208, 47.605816209151087 ], [ -122.322976436674622, 47.605986266461649 ], [ -122.323199521014374, 47.606512616314873 ], [ -122.32300122569039, 47.606718644524072 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323414657931082, 47.604743830397794 ], [ -122.32274281297542, 47.604889368599771 ], [ -122.322348100288693, 47.603947426732176 ], [ -122.322362067280281, 47.603917653919481 ], [ -122.323714247745997, 47.603894194469852 ], [ -122.323414657931082, 47.604743830397794 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323363163919183, 47.602204189117899 ], [ -122.323182599347604, 47.602463418424492 ], [ -122.323121704523999, 47.602474244484576 ], [ -122.321623787382364, 47.601974053738417 ], [ -122.321624291970224, 47.600732479301428 ], [ -122.322022950443895, 47.600459574181123 ], [ -122.322275844154561, 47.600454925548924 ], [ -122.322796262018969, 47.60075745939848 ], [ -122.323363163919183, 47.602204189117899 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.321949396142529, 47.60921299146856 ], [ -122.321706353058801, 47.608675458224951 ], [ -122.321708964943966, 47.608655216379162 ], [ -122.322729472584015, 47.607719398169856 ], [ -122.323147784799218, 47.607876515002744 ], [ -122.323374369922206, 47.608432673814505 ], [ -122.322225658625484, 47.609475067364194 ], [ -122.321949396142529, 47.60921299146856 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.26666666666666666 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320869017759762, 47.60967853036928 ], [ -122.321949396142529, 47.60921299146856 ], [ -122.322225658625484, 47.609475067364194 ], [ -122.322288578115874, 47.609624517980826 ], [ -122.32100512642721, 47.6101533575982 ], [ -122.320869017759762, 47.60967853036928 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323714247745997, 47.603894194469852 ], [ -122.322362067280281, 47.603917653919481 ], [ -122.322132531225691, 47.603373860132805 ], [ -122.323121704523999, 47.602474244484576 ], [ -122.323182599347604, 47.602463418424492 ], [ -122.323766801840989, 47.603846000293146 ], [ -122.323714247745997, 47.603894194469852 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.323147784799218, 47.607876515002744 ], [ -122.322729472584015, 47.607719398169856 ], [ -122.322491573412634, 47.607155189220336 ], [ -122.32300122569039, 47.606718644524072 ], [ -122.323384619601711, 47.607659977469417 ], [ -122.323147784799218, 47.607876515002744 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.322327740543543, 47.605270958137304 ], [ -122.321898677421629, 47.60510305760743 ], [ -122.321671443201808, 47.604554761224151 ], [ -122.322348100288693, 47.603947426732176 ], [ -122.32274281297542, 47.604889368599771 ], [ -122.322327740543543, 47.605270958137304 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.322327740543543, 47.605270958137304 ], [ -122.322556125783208, 47.605816209151087 ], [ -122.321862415293936, 47.606449117497021 ], [ -122.321457035439352, 47.606293404103653 ], [ -122.321227324862406, 47.605713192889567 ], [ -122.321898677421629, 47.60510305760743 ], [ -122.322327740543543, 47.605270958137304 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.322729472584015, 47.607719398169856 ], [ -122.321708964943966, 47.608655216379162 ], [ -122.321359864394751, 47.607670734285811 ], [ -122.322096215230474, 47.60700446812411 ], [ -122.322491573412634, 47.607155189220336 ], [ -122.322729472584015, 47.607719398169856 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.322348100288693, 47.603947426732176 ], [ -122.321671443201808, 47.604554761224151 ], [ -122.321414290868105, 47.604448320960948 ], [ -122.321376975512479, 47.604400244385651 ], [ -122.321181798589507, 47.603874961155675 ], [ -122.321460947876105, 47.603121858228548 ], [ -122.322132531225691, 47.603373860132805 ], [ -122.322362067280281, 47.603917653919481 ], [ -122.322348100288693, 47.603947426732176 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.321736861462341, 47.598842802181501 ], [ -122.320570189908651, 47.598371875634648 ], [ -122.320565510389102, 47.598337520612532 ], [ -122.320596766769583, 47.598261361087623 ], [ -122.321594382598605, 47.597810157247928 ], [ -122.322027886421125, 47.597965479554851 ], [ -122.321811510430493, 47.598777535729269 ], [ -122.321736861462341, 47.598842802181501 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.322022950443895, 47.600459574181123 ], [ -122.321624291970224, 47.600732479301428 ], [ -122.320503790029278, 47.600587577221241 ], [ -122.320382710801411, 47.600437364485444 ], [ -122.320330873646242, 47.599403893741986 ], [ -122.320331536007217, 47.599401506653066 ], [ -122.321732534328021, 47.599373609867278 ], [ -122.322022950443895, 47.600459574181123 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.322132531225691, 47.603373860132805 ], [ -122.321460947876105, 47.603121858228548 ], [ -122.321455952799909, 47.60311356868251 ], [ -122.32146048524514, 47.602196348411169 ], [ -122.321623787382364, 47.601974053738417 ], [ -122.323121704523999, 47.602474244484576 ], [ -122.322132531225691, 47.603373860132805 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.321949396142529, 47.60921299146856 ], [ -122.320869017759762, 47.60967853036928 ], [ -122.320141013973696, 47.609681979067581 ], [ -122.320139077297924, 47.608684069630229 ], [ -122.321706353058801, 47.608675458224951 ], [ -122.321949396142529, 47.60921299146856 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.321227324862406, 47.605713192889567 ], [ -122.32121335016933, 47.605708082414864 ], [ -122.320920873339119, 47.604903163751828 ], [ -122.321414290868105, 47.604448320960948 ], [ -122.321671443201808, 47.604554761224151 ], [ -122.321898677421629, 47.60510305760743 ], [ -122.321227324862406, 47.605713192889567 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.322096215230474, 47.60700446812411 ], [ -122.321359864394751, 47.607670734285811 ], [ -122.321342595464458, 47.607661507650235 ], [ -122.320998084184197, 47.606851497483397 ], [ -122.32136027020195, 47.606375068826743 ], [ -122.321457035439352, 47.606293404103653 ], [ -122.321862415293936, 47.606449117497021 ], [ -122.322096215230474, 47.60700446812411 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.321732534328021, 47.599373609867278 ], [ -122.320331536007217, 47.599401506653066 ], [ -122.320332494419631, 47.598765531540984 ], [ -122.320570189908651, 47.598371875634648 ], [ -122.321736861462341, 47.598842802181501 ], [ -122.321732534328021, 47.599373609867278 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.047619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.322027886421125, 47.597965479554851 ], [ -122.321594382598605, 47.597810157247928 ], [ -122.320919117313196, 47.596530042929253 ], [ -122.320930526317852, 47.59635634557862 ], [ -122.322069943975762, 47.596623768630074 ], [ -122.322064494222218, 47.597932561012364 ], [ -122.322027886421125, 47.597965479554851 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.312210402716829, 47.597234765881204 ], [ -122.311927617248784, 47.597096341979956 ], [ -122.311375942599156, 47.596755772981432 ], [ -122.313823488943868, 47.59600970402461 ], [ -122.312210402716829, 47.597234765881204 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.321455952799909, 47.60311356868251 ], [ -122.320427057346777, 47.603125091716862 ], [ -122.320096435142148, 47.602841465585605 ], [ -122.320098711268869, 47.602284518063151 ], [ -122.320166265485881, 47.602205580016346 ], [ -122.32146048524514, 47.602196348411169 ], [ -122.321455952799909, 47.60311356868251 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320919117313196, 47.596530042929253 ], [ -122.321594382598605, 47.597810157247928 ], [ -122.320596766769583, 47.598261361087623 ], [ -122.320760324383329, 47.597173319970032 ], [ -122.320919117313196, 47.596530042929253 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.321414290868105, 47.604448320960948 ], [ -122.320920873339119, 47.604903163751828 ], [ -122.320279042678322, 47.6049016161775 ], [ -122.320771020457215, 47.604407467908395 ], [ -122.321376975512479, 47.604400244385651 ], [ -122.321414290868105, 47.604448320960948 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.321457035439352, 47.606293404103653 ], [ -122.32136027020195, 47.606375068826743 ], [ -122.320109561652899, 47.606292015881898 ], [ -122.320108771446328, 47.605718284326564 ], [ -122.32121335016933, 47.605708082414864 ], [ -122.321227324862406, 47.605713192889567 ], [ -122.321457035439352, 47.606293404103653 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.321376975512479, 47.604400244385651 ], [ -122.320771020457215, 47.604407467908395 ], [ -122.320375757101246, 47.603927453959997 ], [ -122.320417815714563, 47.603883755363327 ], [ -122.321181798589507, 47.603874961155675 ], [ -122.321376975512479, 47.604400244385651 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.321706353058801, 47.608675458224951 ], [ -122.320139077297924, 47.608684069630229 ], [ -122.320101193643737, 47.60863866916182 ], [ -122.320139582435331, 47.607901352812867 ], [ -122.320411703742877, 47.60769211259575 ], [ -122.321342595464458, 47.607661507650235 ], [ -122.321359864394751, 47.607670734285811 ], [ -122.321708964943966, 47.608655216379162 ], [ -122.321706353058801, 47.608675458224951 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320375757101246, 47.603927453959997 ], [ -122.320771020457215, 47.604407467908395 ], [ -122.320279042678322, 47.6049016161775 ], [ -122.320107053171441, 47.604943962946294 ], [ -122.31999524977617, 47.60478562920855 ], [ -122.320004826096778, 47.604152401770634 ], [ -122.320375757101246, 47.603927453959997 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320004826096778, 47.604152401770634 ], [ -122.319400084537691, 47.603686641652473 ], [ -122.320089344854111, 47.602846959015977 ], [ -122.320096435142148, 47.602841465585605 ], [ -122.320427057346777, 47.603125091716862 ], [ -122.320417815714563, 47.603883755363327 ], [ -122.320375757101246, 47.603927453959997 ], [ -122.320004826096778, 47.604152401770634 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320565510389102, 47.598337520612532 ], [ -122.319839540745363, 47.597929096125924 ], [ -122.319860662776918, 47.59755048579737 ], [ -122.320760324383329, 47.597173319970032 ], [ -122.320596766769583, 47.598261361087623 ], [ -122.320565510389102, 47.598337520612532 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.26666666666666666 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320141013973696, 47.609681979067581 ], [ -122.320869017759762, 47.60967853036928 ], [ -122.32100512642721, 47.6101533575982 ], [ -122.320703599999987, 47.610277600000011 ], [ -122.319710039785349, 47.610337167089902 ], [ -122.320141013973696, 47.609681979067581 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320101193643737, 47.60863866916182 ], [ -122.318420023364467, 47.60865955944341 ], [ -122.3181193, 47.608123410447575 ], [ -122.3181193, 47.607726833010311 ], [ -122.318151247141842, 47.60759318230722 ], [ -122.318768487813713, 47.607146533269571 ], [ -122.31912117277993, 47.607139664025709 ], [ -122.320139582435331, 47.607901352812867 ], [ -122.320101193643737, 47.60863866916182 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320411703742877, 47.60769211259575 ], [ -122.320451845333622, 47.606846032255802 ], [ -122.320998084184197, 47.606851497483397 ], [ -122.321342595464458, 47.607661507650235 ], [ -122.320411703742877, 47.60769211259575 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320139582435331, 47.607901352812867 ], [ -122.31912117277993, 47.607139664025709 ], [ -122.320072522551882, 47.606491815878144 ], [ -122.320451845333622, 47.606846032255802 ], [ -122.320411703742877, 47.60769211259575 ], [ -122.320139582435331, 47.607901352812867 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320108771446328, 47.605718284326564 ], [ -122.32010474818513, 47.605712760203481 ], [ -122.320107053171441, 47.604943962946294 ], [ -122.320279042678322, 47.6049016161775 ], [ -122.320920873339119, 47.604903163751828 ], [ -122.32121335016933, 47.605708082414864 ], [ -122.320108771446328, 47.605718284326564 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.53333333333333333 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320998084184197, 47.606851497483397 ], [ -122.320451845333622, 47.606846032255802 ], [ -122.320072522551882, 47.606491815878144 ], [ -122.320109561652899, 47.606292015881898 ], [ -122.32136027020195, 47.606375068826743 ], [ -122.320998084184197, 47.606851497483397 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.321181798589507, 47.603874961155675 ], [ -122.320417815714563, 47.603883755363327 ], [ -122.320427057346777, 47.603125091716862 ], [ -122.321455952799909, 47.60311356868251 ], [ -122.321460947876105, 47.603121858228548 ], [ -122.321181798589507, 47.603874961155675 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7142857142857143 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.32146048524514, 47.602196348411169 ], [ -122.320166265485881, 47.602205580016346 ], [ -122.320175333020188, 47.601142523840387 ], [ -122.320503790029278, 47.600587577221241 ], [ -122.321624291970224, 47.600732479301428 ], [ -122.321623787382364, 47.601974053738417 ], [ -122.32146048524514, 47.602196348411169 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320072522551882, 47.606491815878144 ], [ -122.31912117277993, 47.607139664025709 ], [ -122.318768487813713, 47.607146533269571 ], [ -122.318770811001741, 47.605709033006484 ], [ -122.32010474818513, 47.605712760203481 ], [ -122.320108771446328, 47.605718284326564 ], [ -122.320109561652899, 47.606292015881898 ], [ -122.320072522551882, 47.606491815878144 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.035714285714285712 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320139077297924, 47.608684069630229 ], [ -122.320141013973696, 47.609681979067581 ], [ -122.319710039785349, 47.610337167089902 ], [ -122.318725007751624, 47.610396222888262 ], [ -122.318414485959806, 47.609825736864607 ], [ -122.318420023364467, 47.60865955944341 ], [ -122.320101193643737, 47.60863866916182 ], [ -122.320139077297924, 47.608684069630229 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320382710801411, 47.600437364485444 ], [ -122.318466445500079, 47.600068010358115 ], [ -122.31840020821042, 47.599648559271486 ], [ -122.318436493413842, 47.599451821355309 ], [ -122.320330873646242, 47.599403893741986 ], [ -122.320382710801411, 47.600437364485444 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320330873646242, 47.599403893741986 ], [ -122.318436493413842, 47.599451821355309 ], [ -122.318432654477277, 47.598779278899968 ], [ -122.320332494419631, 47.598765531540984 ], [ -122.320331536007217, 47.599401506653066 ], [ -122.320330873646242, 47.599403893741986 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320098711268869, 47.602284518063151 ], [ -122.319317889035275, 47.602165546628157 ], [ -122.319049024523892, 47.602046610184679 ], [ -122.318903960918604, 47.601781359829111 ], [ -122.318899748490111, 47.60141879584009 ], [ -122.320175333020188, 47.601142523840387 ], [ -122.320166265485881, 47.602205580016346 ], [ -122.320098711268869, 47.602284518063151 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320107053171441, 47.604943962946294 ], [ -122.32010474818513, 47.605712760203481 ], [ -122.318770811001741, 47.605709033006484 ], [ -122.318766733992589, 47.605703723925131 ], [ -122.318769512436305, 47.60479482552298 ], [ -122.31999524977617, 47.60478562920855 ], [ -122.320107053171441, 47.604943962946294 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.41666666666666669 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320570189908651, 47.598371875634648 ], [ -122.320332494419631, 47.598765531540984 ], [ -122.318432654477277, 47.598779278899968 ], [ -122.318431207026578, 47.598775234080371 ], [ -122.318433781251414, 47.597919661855848 ], [ -122.318434394964854, 47.597917932273511 ], [ -122.319839540745363, 47.597929096125924 ], [ -122.320565510389102, 47.598337520612532 ], [ -122.320570189908651, 47.598371875634648 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320089344854111, 47.602846959015977 ], [ -122.319270167039917, 47.602853177197375 ], [ -122.319317889035275, 47.602165546628157 ], [ -122.320098711268869, 47.602284518063151 ], [ -122.320096435142148, 47.602841465585605 ], [ -122.320089344854111, 47.602846959015977 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5357142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.31999524977617, 47.60478562920855 ], [ -122.318769512436305, 47.60479482552298 ], [ -122.318762963982479, 47.604784621626131 ], [ -122.318768468660338, 47.603942082106919 ], [ -122.318936863639721, 47.603683184274196 ], [ -122.319400084537691, 47.603686641652473 ], [ -122.320004826096778, 47.604152401770634 ], [ -122.31999524977617, 47.60478562920855 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47222222222222221 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.320503790029278, 47.600587577221241 ], [ -122.320175333020188, 47.601142523840387 ], [ -122.318899748490111, 47.60141879584009 ], [ -122.318350788176573, 47.600617300194223 ], [ -122.318356301528453, 47.600474221662815 ], [ -122.318454624047845, 47.600098155336333 ], [ -122.318466445500079, 47.600068010358115 ], [ -122.320382710801411, 47.600437364485444 ], [ -122.320503790029278, 47.600587577221241 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.319839540745363, 47.597929096125924 ], [ -122.318434394964854, 47.597917932273511 ], [ -122.318439332213273, 47.595975003611784 ], [ -122.319379, 47.5959922 ], [ -122.319456534323862, 47.596010397423328 ], [ -122.319860662776918, 47.59755048579737 ], [ -122.319839540745363, 47.597929096125924 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.318434394964854, 47.597917932273511 ], [ -122.318433781251414, 47.597919661855848 ], [ -122.315737933326233, 47.597922222623296 ], [ -122.315198159474832, 47.59716769287872 ], [ -122.315060370438289, 47.59656411505464 ], [ -122.314987760252535, 47.59603384426709 ], [ -122.314987657527951, 47.595921293188312 ], [ -122.3160239, 47.5959308 ], [ -122.318439332213273, 47.595975003611784 ], [ -122.318434394964854, 47.597917932273511 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.317065932549013, 47.609808683764939 ], [ -122.317070068348045, 47.609806700658837 ], [ -122.318414485959806, 47.609825736864607 ], [ -122.318725007751624, 47.610396222888262 ], [ -122.3173293, 47.6104799 ], [ -122.317178899999988, 47.6104812 ], [ -122.317064743096068, 47.61048167624908 ], [ -122.317065932549013, 47.609808683764939 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.26666666666666666 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.318414485959806, 47.609825736864607 ], [ -122.317070068348045, 47.609806700658837 ], [ -122.317080787941919, 47.608638062672092 ], [ -122.3181193, 47.608123410447575 ], [ -122.318420023364467, 47.60865955944341 ], [ -122.318414485959806, 47.609825736864607 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.318769512436305, 47.60479482552298 ], [ -122.318766733992589, 47.605703723925131 ], [ -122.317533348095054, 47.605711463298803 ], [ -122.317444639852411, 47.605391113354244 ], [ -122.317446459120021, 47.604782750261712 ], [ -122.318762963982479, 47.604784621626131 ], [ -122.318769512436305, 47.60479482552298 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.42857142857142855 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.319400084537691, 47.603686641652473 ], [ -122.318936863639721, 47.603683184274196 ], [ -122.318825998541058, 47.60340350574257 ], [ -122.318991659870932, 47.60310131431573 ], [ -122.319270167039917, 47.602853177197375 ], [ -122.320089344854111, 47.602846959015977 ], [ -122.319400084537691, 47.603686641652473 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.32142857142857145 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.318899748490111, 47.60141879584009 ], [ -122.318903960918604, 47.601781359829111 ], [ -122.318457292008461, 47.601955830504075 ], [ -122.318043335974764, 47.601755320550282 ], [ -122.318035075116626, 47.601528116355276 ], [ -122.318039856073938, 47.600949471114824 ], [ -122.318350788176573, 47.600617300194223 ], [ -122.318899748490111, 47.60141879584009 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.319270167039917, 47.602853177197375 ], [ -122.318991659870932, 47.60310131431573 ], [ -122.318986913660325, 47.602156818401923 ], [ -122.319049024523892, 47.602046610184679 ], [ -122.319317889035275, 47.602165546628157 ], [ -122.319270167039917, 47.602853177197375 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.318770811001741, 47.605709033006484 ], [ -122.318768487813713, 47.607146533269571 ], [ -122.318151247141842, 47.60759318230722 ], [ -122.317731840674981, 47.607126529554023 ], [ -122.317448286117397, 47.606520320376241 ], [ -122.317449224537143, 47.605890124573705 ], [ -122.317533348095054, 47.605711463298803 ], [ -122.318766733992589, 47.605703723925131 ], [ -122.318770811001741, 47.605709033006484 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.318825998541058, 47.60340350574257 ], [ -122.318812361954613, 47.603391742910325 ], [ -122.318734504618689, 47.602406729645743 ], [ -122.318986913660325, 47.602156818401923 ], [ -122.318991659870932, 47.60310131431573 ], [ -122.318825998541058, 47.60340350574257 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.318825998541058, 47.60340350574257 ], [ -122.318936863639721, 47.603683184274196 ], [ -122.318768468660338, 47.603942082106919 ], [ -122.317449930709955, 47.60394302605485 ], [ -122.317447144938598, 47.603938536485856 ], [ -122.317447949601913, 47.603112766238695 ], [ -122.31839094110228, 47.603107419966008 ], [ -122.318812361954613, 47.603391742910325 ], [ -122.318825998541058, 47.60340350574257 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.318734504618689, 47.602406729645743 ], [ -122.318391766538639, 47.602590696812598 ], [ -122.318077835169206, 47.602313283828558 ], [ -122.318457292008461, 47.601955830504075 ], [ -122.318903960918604, 47.601781359829111 ], [ -122.319049024523892, 47.602046610184679 ], [ -122.318986913660325, 47.602156818401923 ], [ -122.318734504618689, 47.602406729645743 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.318035075116626, 47.601528116355276 ], [ -122.317323603283114, 47.602209766016351 ], [ -122.31730222342955, 47.602186941025124 ], [ -122.317316798264343, 47.601408954011987 ], [ -122.318039856073938, 47.600949471114824 ], [ -122.318035075116626, 47.601528116355276 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.318039856073938, 47.600949471114824 ], [ -122.317316798264343, 47.601408954011987 ], [ -122.31722416848244, 47.601356256201584 ], [ -122.317073724613181, 47.600584820495378 ], [ -122.318356301528453, 47.600474221662815 ], [ -122.318350788176573, 47.600617300194223 ], [ -122.318039856073938, 47.600949471114824 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.318762963982479, 47.604784621626131 ], [ -122.317446459120021, 47.604782750261712 ], [ -122.317444112657753, 47.604779011338017 ], [ -122.317449930709955, 47.60394302605485 ], [ -122.318768468660338, 47.603942082106919 ], [ -122.318762963982479, 47.604784621626131 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.31839094110228, 47.603107419966008 ], [ -122.318391766538639, 47.602590696812598 ], [ -122.318734504618689, 47.602406729645743 ], [ -122.318812361954613, 47.603391742910325 ], [ -122.31839094110228, 47.603107419966008 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.318043335974764, 47.601755320550282 ], [ -122.317580490236551, 47.602309497766583 ], [ -122.317445784185779, 47.602344440417056 ], [ -122.317323603283114, 47.602209766016351 ], [ -122.318035075116626, 47.601528116355276 ], [ -122.318043335974764, 47.601755320550282 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.46666666666666667 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.318356301528453, 47.600474221662815 ], [ -122.317073724613181, 47.600584820495378 ], [ -122.316652310050202, 47.600381453584916 ], [ -122.316708449887557, 47.600214926242074 ], [ -122.318454624047845, 47.600098155336333 ], [ -122.318356301528453, 47.600474221662815 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.317445784185779, 47.602344440417056 ], [ -122.317444179045225, 47.603106710206241 ], [ -122.31585222335714, 47.603107285265494 ], [ -122.315858403289411, 47.602185129725726 ], [ -122.315859677265109, 47.602182809287982 ], [ -122.31730222342955, 47.602186941025124 ], [ -122.317323603283114, 47.602209766016351 ], [ -122.317445784185779, 47.602344440417056 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.318077835169206, 47.602313283828558 ], [ -122.317580490236551, 47.602309497766583 ], [ -122.318043335974764, 47.601755320550282 ], [ -122.318457292008461, 47.601955830504075 ], [ -122.318077835169206, 47.602313283828558 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.318436493413842, 47.599451821355309 ], [ -122.31840020821042, 47.599648559271486 ], [ -122.31673875455634, 47.5996084662779 ], [ -122.316095498349213, 47.598772530400907 ], [ -122.318431207026578, 47.598775234080371 ], [ -122.318432654477277, 47.598779278899968 ], [ -122.318436493413842, 47.599451821355309 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.31839094110228, 47.603107419966008 ], [ -122.317447949601913, 47.603112766238695 ], [ -122.317444179045225, 47.603106710206241 ], [ -122.317445784185779, 47.602344440417056 ], [ -122.317580490236551, 47.602309497766583 ], [ -122.318077835169206, 47.602313283828558 ], [ -122.318391766538639, 47.602590696812598 ], [ -122.31839094110228, 47.603107419966008 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.317316798264343, 47.601408954011987 ], [ -122.31730222342955, 47.602186941025124 ], [ -122.315859677265109, 47.602182809287982 ], [ -122.315859619363948, 47.601113432678083 ], [ -122.315922179259047, 47.601070657599038 ], [ -122.315946037732317, 47.601058405524043 ], [ -122.31722416848244, 47.601356256201584 ], [ -122.317316798264343, 47.601408954011987 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.317447949601913, 47.603112766238695 ], [ -122.317447144938598, 47.603938536485856 ], [ -122.315492335364951, 47.603934768632207 ], [ -122.315492381894202, 47.603897322768503 ], [ -122.31585222335714, 47.603107285265494 ], [ -122.317444179045225, 47.603106710206241 ], [ -122.317447949601913, 47.603112766238695 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5357142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.317080787941919, 47.608638062672092 ], [ -122.316128151019569, 47.608640918053801 ], [ -122.316123258026053, 47.608635387592813 ], [ -122.316125682438937, 47.607748927949864 ], [ -122.316130305218124, 47.607739268113683 ], [ -122.3181193, 47.607726833010311 ], [ -122.3181193, 47.608123410447575 ], [ -122.317080787941919, 47.608638062672092 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.31722416848244, 47.601356256201584 ], [ -122.315946037732317, 47.601058405524043 ], [ -122.316161019179845, 47.600796440876628 ], [ -122.316652310050202, 47.600381453584916 ], [ -122.317073724613181, 47.600584820495378 ], [ -122.31722416848244, 47.601356256201584 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.316144404678965, 47.60980513821481 ], [ -122.317065932549013, 47.609808683764939 ], [ -122.317064743096068, 47.61048167624908 ], [ -122.3169392, 47.6104822 ], [ -122.316114980748338, 47.610424393046415 ], [ -122.316144404678965, 47.60980513821481 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.318454624047845, 47.600098155336333 ], [ -122.316708449887557, 47.600214926242074 ], [ -122.31673875455634, 47.5996084662779 ], [ -122.31840020821042, 47.599648559271486 ], [ -122.318466445500079, 47.600068010358115 ], [ -122.318454624047845, 47.600098155336333 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.318431207026578, 47.598775234080371 ], [ -122.316095498349213, 47.598772530400907 ], [ -122.316030912595366, 47.598732688565313 ], [ -122.315737933326233, 47.597922222623296 ], [ -122.318433781251414, 47.597919661855848 ], [ -122.318431207026578, 47.598775234080371 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.316708449887557, 47.600214926242074 ], [ -122.316652310050202, 47.600381453584916 ], [ -122.316161019179845, 47.600796440876628 ], [ -122.315954343610599, 47.598866591293884 ], [ -122.316030912595366, 47.598732688565313 ], [ -122.316095498349213, 47.598772530400907 ], [ -122.31673875455634, 47.5996084662779 ], [ -122.316708449887557, 47.600214926242074 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.19047619047619047 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.3181193, 47.607726833010311 ], [ -122.316130305218124, 47.607739268113683 ], [ -122.316123989344618, 47.607142418066672 ], [ -122.316131299781475, 47.607125975925214 ], [ -122.317731840674981, 47.607126529554023 ], [ -122.318151247141842, 47.60759318230722 ], [ -122.3181193, 47.607726833010311 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.317070068348045, 47.609806700658837 ], [ -122.317065932549013, 47.609808683764939 ], [ -122.316144404678965, 47.60980513821481 ], [ -122.316125297129901, 47.609782127994208 ], [ -122.316128151019569, 47.608640918053801 ], [ -122.317080787941919, 47.608638062672092 ], [ -122.317070068348045, 47.609806700658837 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.316130464796728, 47.606524508589544 ], [ -122.317448286117397, 47.606520320376241 ], [ -122.317731840674981, 47.607126529554023 ], [ -122.316131299781475, 47.607125975925214 ], [ -122.316130464796728, 47.606524508589544 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.316131299781475, 47.607125975925214 ], [ -122.316123989344618, 47.607142418066672 ], [ -122.314532248824094, 47.607121651543466 ], [ -122.314824251448897, 47.606525445373471 ], [ -122.316126039894939, 47.606515431616195 ], [ -122.316130464796728, 47.606524508589544 ], [ -122.316131299781475, 47.607125975925214 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.317449930709955, 47.60394302605485 ], [ -122.317444112657753, 47.604779011338017 ], [ -122.315951320941068, 47.604774618189921 ], [ -122.315487652004876, 47.604277267319162 ], [ -122.315487234448497, 47.603950523136803 ], [ -122.315492335364951, 47.603934768632207 ], [ -122.317447144938598, 47.603938536485856 ], [ -122.317449930709955, 47.60394302605485 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.315922179259047, 47.601070657599038 ], [ -122.315699536586962, 47.599203170827174 ], [ -122.315954343610599, 47.598866591293884 ], [ -122.316161019179845, 47.600796440876628 ], [ -122.315946037732317, 47.601058405524043 ], [ -122.315922179259047, 47.601070657599038 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.317448286117397, 47.606520320376241 ], [ -122.316130464796728, 47.606524508589544 ], [ -122.316126039894939, 47.606515431616195 ], [ -122.316128860876717, 47.60589409842283 ], [ -122.317449224537143, 47.605890124573705 ], [ -122.317448286117397, 47.606520320376241 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.316125297129901, 47.609782127994208 ], [ -122.314812743059619, 47.609766871238477 ], [ -122.314815944432866, 47.608637565195487 ], [ -122.314817711844228, 47.608635611145232 ], [ -122.316123258026053, 47.608635387592813 ], [ -122.316128151019569, 47.608640918053801 ], [ -122.316125297129901, 47.609782127994208 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.315951320941068, 47.604774618189921 ], [ -122.317444112657753, 47.604779011338017 ], [ -122.317446459120021, 47.604782750261712 ], [ -122.317444639852411, 47.605391113354244 ], [ -122.316124543493686, 47.6053872379713 ], [ -122.315951320941068, 47.604774618189921 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.316124543493686, 47.6053872379713 ], [ -122.316122310307819, 47.605880507092145 ], [ -122.314828186179454, 47.605891986729624 ], [ -122.314832369762399, 47.604965178842008 ], [ -122.315487652004876, 47.604277267319162 ], [ -122.315951320941068, 47.604774618189921 ], [ -122.316124543493686, 47.6053872379713 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.316124543493686, 47.6053872379713 ], [ -122.317444639852411, 47.605391113354244 ], [ -122.317533348095054, 47.605711463298803 ], [ -122.317449224537143, 47.605890124573705 ], [ -122.316128860876717, 47.60589409842283 ], [ -122.316122310307819, 47.605880507092145 ], [ -122.316124543493686, 47.6053872379713 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.315859677265109, 47.602182809287982 ], [ -122.315858403289411, 47.602185129725726 ], [ -122.314564170972943, 47.602176976062118 ], [ -122.314545895225052, 47.602163647872302 ], [ -122.314527796229001, 47.601269982010976 ], [ -122.315052207663001, 47.600751564579248 ], [ -122.315859619363948, 47.601113432678083 ], [ -122.315859677265109, 47.602182809287982 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.315859619363948, 47.601113432678083 ], [ -122.315052207663001, 47.600751564579248 ], [ -122.31489087441669, 47.600443709726541 ], [ -122.314899282198027, 47.599973302004031 ], [ -122.315699536586962, 47.599203170827174 ], [ -122.315922179259047, 47.601070657599038 ], [ -122.315859619363948, 47.601113432678083 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.316126039894939, 47.606515431616195 ], [ -122.314824251448897, 47.606525445373471 ], [ -122.314826375369364, 47.605895654678768 ], [ -122.314828186179454, 47.605891986729624 ], [ -122.316122310307819, 47.605880507092145 ], [ -122.316128860876717, 47.60589409842283 ], [ -122.316126039894939, 47.606515431616195 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.315492335364951, 47.603934768632207 ], [ -122.315487234448497, 47.603950523136803 ], [ -122.313570634580799, 47.603930821058327 ], [ -122.313575551333258, 47.603102053264799 ], [ -122.314569260656427, 47.603100626375742 ], [ -122.315492381894202, 47.603897322768503 ], [ -122.315492335364951, 47.603934768632207 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.31111111111111112 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.315699536586962, 47.599203170827174 ], [ -122.314899282198027, 47.599973302004031 ], [ -122.314502267291061, 47.599620831654704 ], [ -122.314493759795255, 47.598387765631614 ], [ -122.314584537509603, 47.598138180669977 ], [ -122.315198159474832, 47.59716769287872 ], [ -122.315737933326233, 47.597922222623296 ], [ -122.316030912595366, 47.598732688565313 ], [ -122.315954343610599, 47.598866591293884 ], [ -122.315699536586962, 47.599203170827174 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.316130305218124, 47.607739268113683 ], [ -122.316125682438937, 47.607748927949864 ], [ -122.314820085159738, 47.607731726957425 ], [ -122.314530942443369, 47.607123032492666 ], [ -122.314532248824094, 47.607121651543466 ], [ -122.316123989344618, 47.607142418066672 ], [ -122.316130305218124, 47.607739268113683 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7142857142857143 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.314899282198027, 47.599973302004031 ], [ -122.31489087441669, 47.600443709726541 ], [ -122.313506746756474, 47.600434281514715 ], [ -122.313022734627694, 47.599712333582112 ], [ -122.313345780722358, 47.59959890908803 ], [ -122.314502267291061, 47.599620831654704 ], [ -122.314899282198027, 47.599973302004031 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.315487652004876, 47.604277267319162 ], [ -122.314832369762399, 47.604965178842008 ], [ -122.31356123414173, 47.604955297370935 ], [ -122.313568105735698, 47.603934582719184 ], [ -122.313570634580799, 47.603930821058327 ], [ -122.315487234448497, 47.603950523136803 ], [ -122.315487652004876, 47.604277267319162 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.31585222335714, 47.603107285265494 ], [ -122.315492381894202, 47.603897322768503 ], [ -122.314569260656427, 47.603100626375742 ], [ -122.314564170972943, 47.602176976062118 ], [ -122.315858403289411, 47.602185129725726 ], [ -122.31585222335714, 47.603107285265494 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.066666666666666666 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.314812743059619, 47.609766871238477 ], [ -122.316125297129901, 47.609782127994208 ], [ -122.316144404678965, 47.60980513821481 ], [ -122.316114980748338, 47.610424393046415 ], [ -122.314352692554721, 47.610300794244772 ], [ -122.314812743059619, 47.609766871238477 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.316125682438937, 47.607748927949864 ], [ -122.316123258026053, 47.608635387592813 ], [ -122.314817711844228, 47.608635611145232 ], [ -122.314820085159738, 47.607731726957425 ], [ -122.316125682438937, 47.607748927949864 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.314824251448897, 47.606525445373471 ], [ -122.314532248824094, 47.607121651543466 ], [ -122.314530942443369, 47.607123032492666 ], [ -122.313516227071688, 47.607122374512315 ], [ -122.31350665816484, 47.607115549348329 ], [ -122.313511465022017, 47.605866143493444 ], [ -122.314826375369364, 47.605895654678768 ], [ -122.314824251448897, 47.606525445373471 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.314826375369364, 47.605895654678768 ], [ -122.313511465022017, 47.605866143493444 ], [ -122.313242227601052, 47.605291375653067 ], [ -122.313352211657872, 47.605170413554553 ], [ -122.31356123414173, 47.604955297370935 ], [ -122.314832369762399, 47.604965178842008 ], [ -122.314828186179454, 47.605891986729624 ], [ -122.314826375369364, 47.605895654678768 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5357142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.314352692554721, 47.610300794244772 ], [ -122.3142658, 47.6102947 ], [ -122.314045199999981, 47.6102784 ], [ -122.313534066583259, 47.610129978668468 ], [ -122.313535025672806, 47.60862648591187 ], [ -122.314815944432866, 47.608637565195487 ], [ -122.314812743059619, 47.609766871238477 ], [ -122.314352692554721, 47.610300794244772 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.314569260656427, 47.603100626375742 ], [ -122.313575551333258, 47.603102053264799 ], [ -122.31357383084206, 47.603099429526111 ], [ -122.313573348300082, 47.602230302485403 ], [ -122.314545895225052, 47.602163647872302 ], [ -122.314564170972943, 47.602176976062118 ], [ -122.314569260656427, 47.603100626375742 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.314493759795255, 47.598387765631614 ], [ -122.313345780722358, 47.59959890908803 ], [ -122.313022734627694, 47.599712333582112 ], [ -122.312767949211207, 47.599613169066501 ], [ -122.3126792262793, 47.599195486366156 ], [ -122.313388537895293, 47.598657708655061 ], [ -122.314584537509603, 47.598138180669977 ], [ -122.314493759795255, 47.598387765631614 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.313509282972205, 47.602152976898481 ], [ -122.313512333324852, 47.60128584483477 ], [ -122.314527796229001, 47.601269982010976 ], [ -122.314545895225052, 47.602163647872302 ], [ -122.313573348300082, 47.602230302485403 ], [ -122.313509282972205, 47.602152976898481 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.313573348300082, 47.602230302485403 ], [ -122.31357383084206, 47.603099429526111 ], [ -122.313154027760092, 47.603098313433328 ], [ -122.312904163952439, 47.602680596331489 ], [ -122.313283836259075, 47.602166078193001 ], [ -122.313509282972205, 47.602152976898481 ], [ -122.313573348300082, 47.602230302485403 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.313503760340211, 47.601273125123548 ], [ -122.313506746756474, 47.600434281514715 ], [ -122.31489087441669, 47.600443709726541 ], [ -122.315052207663001, 47.600751564579248 ], [ -122.314527796229001, 47.601269982010976 ], [ -122.313512333324852, 47.60128584483477 ], [ -122.313503760340211, 47.601273125123548 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.313512333324852, 47.60128584483477 ], [ -122.313509282972205, 47.602152976898481 ], [ -122.313283836259075, 47.602166078193001 ], [ -122.312513770115856, 47.60216922890428 ], [ -122.31223151452987, 47.602154963792948 ], [ -122.312231581743262, 47.601275879813734 ], [ -122.312235101764045, 47.60127040203097 ], [ -122.313503760340211, 47.601273125123548 ], [ -122.313512333324852, 47.60128584483477 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.314820085159738, 47.607731726957425 ], [ -122.314817711844228, 47.608635611145232 ], [ -122.314815944432866, 47.608637565195487 ], [ -122.313535025672806, 47.60862648591187 ], [ -122.313512180800657, 47.608601736158349 ], [ -122.313516227071688, 47.607122374512315 ], [ -122.314530942443369, 47.607123032492666 ], [ -122.314820085159738, 47.607731726957425 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.32142857142857145 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.313506746756474, 47.600434281514715 ], [ -122.313503760340211, 47.601273125123548 ], [ -122.312235101764045, 47.60127040203097 ], [ -122.312234396319909, 47.600433424653097 ], [ -122.312743345679834, 47.599632922200371 ], [ -122.312767949211207, 47.599613169066501 ], [ -122.313022734627694, 47.599712333582112 ], [ -122.313506746756474, 47.600434281514715 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.312840565171498, 47.609214360214928 ], [ -122.312869170402863, 47.60921359038575 ], [ -122.313449651410849, 47.610105466453284 ], [ -122.31243715060333, 47.609811459618463 ], [ -122.312840565171498, 47.609214360214928 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.313511465022017, 47.605866143493444 ], [ -122.31350665816484, 47.607115549348329 ], [ -122.312208963618204, 47.607121294769911 ], [ -122.31220096160223, 47.607115711494949 ], [ -122.312210571760559, 47.605275151019306 ], [ -122.312298285171124, 47.605274220624871 ], [ -122.313242227601052, 47.605291375653067 ], [ -122.313511465022017, 47.605866143493444 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.52380952380952384 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.314584537509603, 47.598138180669977 ], [ -122.313388537895293, 47.598657708655061 ], [ -122.313448232074464, 47.598199162323631 ], [ -122.313548069872979, 47.598021130454718 ], [ -122.315060370438289, 47.59656411505464 ], [ -122.315198159474832, 47.59716769287872 ], [ -122.314584537509603, 47.598138180669977 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.314502267291061, 47.599620831654704 ], [ -122.313345780722358, 47.59959890908803 ], [ -122.314493759795255, 47.598387765631614 ], [ -122.314502267291061, 47.599620831654704 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.313575551333258, 47.603102053264799 ], [ -122.313570634580799, 47.603930821058327 ], [ -122.313568105735698, 47.603934582719184 ], [ -122.313226227891363, 47.603931718735325 ], [ -122.312898624511774, 47.60351718551162 ], [ -122.313122747453917, 47.603100371503537 ], [ -122.313154027760092, 47.603098313433328 ], [ -122.31357383084206, 47.603099429526111 ], [ -122.313575551333258, 47.603102053264799 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.3126792262793, 47.599195486366156 ], [ -122.31259024126247, 47.599020221255067 ], [ -122.312524785268806, 47.598778791702614 ], [ -122.313448232074464, 47.598199162323631 ], [ -122.313388537895293, 47.598657708655061 ], [ -122.3126792262793, 47.599195486366156 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.313448232074464, 47.598199162323631 ], [ -122.312524785268806, 47.598778791702614 ], [ -122.312505900817342, 47.598723504153782 ], [ -122.312487621617265, 47.598444238597139 ], [ -122.313548069872979, 47.598021130454718 ], [ -122.313448232074464, 47.598199162323631 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.31356123414173, 47.604955297370935 ], [ -122.313352211657872, 47.605170413554553 ], [ -122.312894758756812, 47.60433924489373 ], [ -122.313186679058674, 47.603934256869273 ], [ -122.313226227891363, 47.603931718735325 ], [ -122.313568105735698, 47.603934582719184 ], [ -122.31356123414173, 47.604955297370935 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.46666666666666667 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.313548069872979, 47.598021130454718 ], [ -122.312487621617265, 47.598444238597139 ], [ -122.312449684201084, 47.598237290258687 ], [ -122.314987760252535, 47.59603384426709 ], [ -122.315060370438289, 47.59656411505464 ], [ -122.313548069872979, 47.598021130454718 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.312487621617265, 47.598444238597139 ], [ -122.312505900817342, 47.598723504153782 ], [ -122.311769011880571, 47.598596998950711 ], [ -122.31161730960018, 47.598332539963138 ], [ -122.311893782228424, 47.597921143873549 ], [ -122.312209236671109, 47.597925388845013 ], [ -122.312449684201084, 47.598237290258687 ], [ -122.312487621617265, 47.598444238597139 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.313242227601052, 47.605291375653067 ], [ -122.312298285171124, 47.605274220624871 ], [ -122.312865745244252, 47.604341458129767 ], [ -122.312894758756812, 47.60433924489373 ], [ -122.313352211657872, 47.605170413554553 ], [ -122.313242227601052, 47.605291375653067 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.31259024126247, 47.599020221255067 ], [ -122.310933416641291, 47.599019033850915 ], [ -122.310811571572188, 47.598647460759722 ], [ -122.311409990166922, 47.598588415443054 ], [ -122.311769011880571, 47.598596998950711 ], [ -122.312505900817342, 47.598723504153782 ], [ -122.312524785268806, 47.598778791702614 ], [ -122.31259024126247, 47.599020221255067 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.313154027760092, 47.603098313433328 ], [ -122.313122747453917, 47.603100371503537 ], [ -122.312608596529145, 47.603094502046716 ], [ -122.312874364683054, 47.60268030781851 ], [ -122.312904163952439, 47.602680596331489 ], [ -122.313154027760092, 47.603098313433328 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.313512180800657, 47.608601736158349 ], [ -122.313268763119922, 47.608612550100609 ], [ -122.312414800692437, 47.608610592507318 ], [ -122.312205087627305, 47.608601125296445 ], [ -122.312208963618204, 47.607121294769911 ], [ -122.31350665816484, 47.607115549348329 ], [ -122.313516227071688, 47.607122374512315 ], [ -122.313512180800657, 47.608601736158349 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.313226227891363, 47.603931718735325 ], [ -122.313186679058674, 47.603934256869273 ], [ -122.312620683212714, 47.60392789566361 ], [ -122.312867016877036, 47.603518515935015 ], [ -122.312898624511774, 47.60351718551162 ], [ -122.313226227891363, 47.603931718735325 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.313535025672806, 47.60862648591187 ], [ -122.313534066583259, 47.610129978668468 ], [ -122.313449651410849, 47.610105466453284 ], [ -122.312869170402863, 47.60921359038575 ], [ -122.313268763119922, 47.608612550100609 ], [ -122.313512180800657, 47.608601736158349 ], [ -122.313535025672806, 47.60862648591187 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.312869170402863, 47.60921359038575 ], [ -122.312840565171498, 47.609214360214928 ], [ -122.312414800692437, 47.608610592507318 ], [ -122.313268763119922, 47.608612550100609 ], [ -122.312869170402863, 47.60921359038575 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.313283836259075, 47.602166078193001 ], [ -122.312904163952439, 47.602680596331489 ], [ -122.312874364683054, 47.60268030781851 ], [ -122.312513770115856, 47.60216922890428 ], [ -122.313283836259075, 47.602166078193001 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.313122747453917, 47.603100371503537 ], [ -122.312898624511774, 47.60351718551162 ], [ -122.312867016877036, 47.603518515935015 ], [ -122.312533180303859, 47.603098726037238 ], [ -122.312608596529145, 47.603094502046716 ], [ -122.313122747453917, 47.603100371503537 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.30555555555555558 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.312210402716829, 47.597234765881204 ], [ -122.313823488943868, 47.59600970402461 ], [ -122.3139895, 47.5959591 ], [ -122.31416, 47.5959137 ], [ -122.314987657527951, 47.595921293188312 ], [ -122.314987760252535, 47.59603384426709 ], [ -122.312449684201084, 47.598237290258687 ], [ -122.312209236671109, 47.597925388845013 ], [ -122.312210402716829, 47.597234765881204 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.312209236671109, 47.597925388845013 ], [ -122.311893782228424, 47.597921143873549 ], [ -122.311841852450939, 47.59791589410586 ], [ -122.311625400944649, 47.5974927 ], [ -122.311927617248784, 47.597096341979956 ], [ -122.312210402716829, 47.597234765881204 ], [ -122.312209236671109, 47.597925388845013 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.312620683212714, 47.60392789566361 ], [ -122.312519128333179, 47.603934334525974 ], [ -122.312198608034535, 47.603935308870263 ], [ -122.312076085028792, 47.60374647859107 ], [ -122.312076115704784, 47.603286829601792 ], [ -122.312203857756117, 47.603094765382636 ], [ -122.312533180303859, 47.603098726037238 ], [ -122.312867016877036, 47.603518515935015 ], [ -122.312620683212714, 47.60392789566361 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.312874364683054, 47.60268030781851 ], [ -122.312608596529145, 47.603094502046716 ], [ -122.312533180303859, 47.603098726037238 ], [ -122.312203857756117, 47.603094765382636 ], [ -122.312200656388114, 47.602194113854196 ], [ -122.31223151452987, 47.602154963792948 ], [ -122.312513770115856, 47.60216922890428 ], [ -122.312874364683054, 47.60268030781851 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.312894758756812, 47.60433924489373 ], [ -122.312865745244252, 47.604341458129767 ], [ -122.312519128333179, 47.603934334525974 ], [ -122.312620683212714, 47.60392789566361 ], [ -122.313186679058674, 47.603934256869273 ], [ -122.312894758756812, 47.60433924489373 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.312298285171124, 47.605274220624871 ], [ -122.312210571760559, 47.605275151019306 ], [ -122.312193030797744, 47.605263112150894 ], [ -122.312198608034535, 47.603935308870263 ], [ -122.312519128333179, 47.603934334525974 ], [ -122.312865745244252, 47.604341458129767 ], [ -122.312298285171124, 47.605274220624871 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.312414800692437, 47.608610592507318 ], [ -122.312840565171498, 47.609214360214928 ], [ -122.31243715060333, 47.609811459618463 ], [ -122.3122015400658, 47.609743043763508 ], [ -122.312203820452027, 47.608602470576379 ], [ -122.312205087627305, 47.608601125296445 ], [ -122.312414800692437, 47.608610592507318 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.311534672615565, 47.609208285539111 ], [ -122.311563290534124, 47.609208690318731 ], [ -122.311800257946928, 47.60962652071013 ], [ -122.3114317, 47.609519499999983 ], [ -122.311343385232391, 47.609482445201074 ], [ -122.311534672615565, 47.609208285539111 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7142857142857143 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.312767949211207, 47.599613169066501 ], [ -122.312743345679834, 47.599632922200371 ], [ -122.310936747902133, 47.599619678687866 ], [ -122.310933416641291, 47.599019033850915 ], [ -122.31259024126247, 47.599020221255067 ], [ -122.3126792262793, 47.599195486366156 ], [ -122.312767949211207, 47.599613169066501 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.311769011880571, 47.598596998950711 ], [ -122.311409990166922, 47.598588415443054 ], [ -122.311582428077486, 47.598331334380553 ], [ -122.31161730960018, 47.598332539963138 ], [ -122.311769011880571, 47.598596998950711 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.22222222222222221 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.312203820452027, 47.608602470576379 ], [ -122.311978145894145, 47.60861112663963 ], [ -122.311080130083667, 47.608602638327646 ], [ -122.310897336113626, 47.608593256259041 ], [ -122.310901373593111, 47.607115875215115 ], [ -122.310908315943436, 47.607111043646547 ], [ -122.31220096160223, 47.607115711494949 ], [ -122.312208963618204, 47.607121294769911 ], [ -122.312205087627305, 47.608601125296445 ], [ -122.312203820452027, 47.608602470576379 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.311563290534124, 47.609208690318731 ], [ -122.311978145894145, 47.60861112663963 ], [ -122.312203820452027, 47.608602470576379 ], [ -122.3122015400658, 47.609743043763508 ], [ -122.311800257946928, 47.60962652071013 ], [ -122.311563290534124, 47.609208690318731 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.31223151452987, 47.602154963792948 ], [ -122.312200656388114, 47.602194113854196 ], [ -122.311418414545443, 47.602187673063838 ], [ -122.310929472151088, 47.602036825480539 ], [ -122.310933022520899, 47.601319650781825 ], [ -122.310968126553774, 47.601268939410261 ], [ -122.312231581743262, 47.601275879813734 ], [ -122.31223151452987, 47.602154963792948 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.311927617248784, 47.597096341979956 ], [ -122.311625400944649, 47.5974927 ], [ -122.311587071296302, 47.5974927 ], [ -122.311043643106245, 47.596857065582718 ], [ -122.311375942599156, 47.596755772981432 ], [ -122.311927617248784, 47.597096341979956 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.312198608034535, 47.603935308870263 ], [ -122.312193030797744, 47.605263112150894 ], [ -122.31141571711521, 47.605262354371099 ], [ -122.31142110343535, 47.603947194535436 ], [ -122.311533345580429, 47.603905275705735 ], [ -122.312076085028792, 47.60374647859107 ], [ -122.312198608034535, 47.603935308870263 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.31161730960018, 47.598332539963138 ], [ -122.311582428077486, 47.598331334380553 ], [ -122.311249403565697, 47.59791865864532 ], [ -122.311334573752916, 47.59791223437977 ], [ -122.311841852450939, 47.59791589410586 ], [ -122.311893782228424, 47.597921143873549 ], [ -122.31161730960018, 47.598332539963138 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.311587071296302, 47.5974927 ], [ -122.311334573752916, 47.59791223437977 ], [ -122.311249403565697, 47.59791865864532 ], [ -122.310293726303669, 47.597917858437086 ], [ -122.310290476706342, 47.597908044653209 ], [ -122.310291728914649, 47.597086266487437 ], [ -122.311043643106245, 47.596857065582718 ], [ -122.311587071296302, 47.5974927 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.311841852450939, 47.59791589410586 ], [ -122.311334573752916, 47.59791223437977 ], [ -122.311587071296302, 47.5974927 ], [ -122.311625400944649, 47.5974927 ], [ -122.311841852450939, 47.59791589410586 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.311978145894145, 47.60861112663963 ], [ -122.311563290534124, 47.609208690318731 ], [ -122.311534672615565, 47.609208285539111 ], [ -122.311080130083667, 47.608602638327646 ], [ -122.311978145894145, 47.60861112663963 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.312235101764045, 47.60127040203097 ], [ -122.312231581743262, 47.601275879813734 ], [ -122.310968126553774, 47.601268939410261 ], [ -122.310972530032117, 47.600439933800224 ], [ -122.312234396319909, 47.600433424653097 ], [ -122.312235101764045, 47.60127040203097 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.311582428077486, 47.598331334380553 ], [ -122.311409990166922, 47.598588415443054 ], [ -122.310811571572188, 47.598647460759722 ], [ -122.310293688485302, 47.597926421889575 ], [ -122.310293726303669, 47.597917858437086 ], [ -122.311249403565697, 47.59791865864532 ], [ -122.311582428077486, 47.598331334380553 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.310936747902133, 47.599619678687866 ], [ -122.312743345679834, 47.599632922200371 ], [ -122.312234396319909, 47.600433424653097 ], [ -122.310972530032117, 47.600439933800224 ], [ -122.31092953760789, 47.600376549732879 ], [ -122.310933843203031, 47.599624466995408 ], [ -122.310936747902133, 47.599619678687866 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.25 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.310933843203031, 47.599624466995408 ], [ -122.309627153509112, 47.59962413047991 ], [ -122.309623791300794, 47.599023930857193 ], [ -122.30973506002077, 47.598686932457149 ], [ -122.310293688485302, 47.597926421889575 ], [ -122.310811571572188, 47.598647460759722 ], [ -122.310933416641291, 47.599019033850915 ], [ -122.310936747902133, 47.599619678687866 ], [ -122.310933843203031, 47.599624466995408 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.312203857756117, 47.603094765382636 ], [ -122.312076115704784, 47.603286829601792 ], [ -122.311547899804864, 47.603133462317622 ], [ -122.311420815901755, 47.603086080496574 ], [ -122.311418414545443, 47.602187673063838 ], [ -122.312200656388114, 47.602194113854196 ], [ -122.312203857756117, 47.603094765382636 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.311547899804864, 47.603133462317622 ], [ -122.311288184155131, 47.603520228055437 ], [ -122.311259476008161, 47.603520915433606 ], [ -122.31094836450707, 47.603087087729286 ], [ -122.311420815901755, 47.603086080496574 ], [ -122.311547899804864, 47.603133462317622 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.31092953760789, 47.600376549732879 ], [ -122.310972530032117, 47.600439933800224 ], [ -122.310968126553774, 47.601268939410261 ], [ -122.310933022520899, 47.601319650781825 ], [ -122.310601403319964, 47.601290468292149 ], [ -122.310306920035146, 47.600846879546602 ], [ -122.310597166866899, 47.600405704362302 ], [ -122.31092953760789, 47.600376549732879 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.310597166866899, 47.600405704362302 ], [ -122.309947536025419, 47.60040652981445 ], [ -122.309624363522303, 47.60038046440166 ], [ -122.309626480631351, 47.599625285884215 ], [ -122.309627153509112, 47.59962413047991 ], [ -122.310933843203031, 47.599624466995408 ], [ -122.31092953760789, 47.600376549732879 ], [ -122.310597166866899, 47.600405704362302 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.311420815901755, 47.603086080496574 ], [ -122.31094836450707, 47.603087087729286 ], [ -122.31074624124598, 47.603075325096498 ], [ -122.310751123410711, 47.602212009424207 ], [ -122.310929472151088, 47.602036825480539 ], [ -122.311418414545443, 47.602187673063838 ], [ -122.311420815901755, 47.603086080496574 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.311533345580429, 47.603905275705735 ], [ -122.311288184155131, 47.603520228055437 ], [ -122.311547899804864, 47.603133462317622 ], [ -122.312076115704784, 47.603286829601792 ], [ -122.312076085028792, 47.60374647859107 ], [ -122.311533345580429, 47.603905275705735 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.312210571760559, 47.605275151019306 ], [ -122.31220096160223, 47.607115711494949 ], [ -122.310908315943436, 47.607111043646547 ], [ -122.310917149506281, 47.605340933548263 ], [ -122.31141571711521, 47.605262354371099 ], [ -122.312193030797744, 47.605263112150894 ], [ -122.312210571760559, 47.605275151019306 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.31141571711521, 47.605262354371099 ], [ -122.310917149506281, 47.605340933548263 ], [ -122.31074710824339, 47.605247531381522 ], [ -122.310752531035561, 47.603960727447706 ], [ -122.310972198113618, 47.603946907511585 ], [ -122.31142110343535, 47.603947194535436 ], [ -122.31141571711521, 47.605262354371099 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.311534672615565, 47.609208285539111 ], [ -122.311343385232391, 47.609482445201074 ], [ -122.310426741574986, 47.60909784308609 ], [ -122.310897336113626, 47.608593256259041 ], [ -122.311080130083667, 47.608602638327646 ], [ -122.311534672615565, 47.609208285539111 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.310293726303669, 47.597917858437086 ], [ -122.310293688485302, 47.597926421889575 ], [ -122.30973506002077, 47.598686932457149 ], [ -122.309162741740224, 47.598589696256873 ], [ -122.308992626670886, 47.598323194636627 ], [ -122.309261330445054, 47.597910900633423 ], [ -122.310290476706342, 47.597908044653209 ], [ -122.310293726303669, 47.597917858437086 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.31142110343535, 47.603947194535436 ], [ -122.310972198113618, 47.603946907511585 ], [ -122.311259476008161, 47.603520915433606 ], [ -122.311288184155131, 47.603520228055437 ], [ -122.311533345580429, 47.603905275705735 ], [ -122.31142110343535, 47.603947194535436 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.308293820117569, 47.607098586214128 ], [ -122.309598424408193, 47.607100850660714 ], [ -122.309578324686456, 47.608741867318308 ], [ -122.3075311, 47.6078829 ], [ -122.307414796014044, 47.607707339084676 ], [ -122.308293820117569, 47.607098586214128 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.310426741574986, 47.60909784308609 ], [ -122.309578324686456, 47.608741867318308 ], [ -122.309598424408193, 47.607100850660714 ], [ -122.30959849487644, 47.607100801280652 ], [ -122.310901373593111, 47.607115875215115 ], [ -122.310897336113626, 47.608593256259041 ], [ -122.310426741574986, 47.60909784308609 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.310972198113618, 47.603946907511585 ], [ -122.310752531035561, 47.603960727447706 ], [ -122.310734113183926, 47.603938227569159 ], [ -122.310735510362974, 47.603088044127141 ], [ -122.31074624124598, 47.603075325096498 ], [ -122.31094836450707, 47.603087087729286 ], [ -122.311259476008161, 47.603520915433606 ], [ -122.310972198113618, 47.603946907511585 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.310908315943436, 47.607111043646547 ], [ -122.310901373593111, 47.607115875215115 ], [ -122.30959849487644, 47.607100801280652 ], [ -122.309600284983034, 47.6052768203391 ], [ -122.309613682051165, 47.605267675721322 ], [ -122.31074710824339, 47.605247531381522 ], [ -122.310917149506281, 47.605340933548263 ], [ -122.310908315943436, 47.607111043646547 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.310751123410711, 47.602212009424207 ], [ -122.309624082166138, 47.602146457486583 ], [ -122.309619275448085, 47.602140383030985 ], [ -122.309621567051835, 47.601317573419394 ], [ -122.309981888396479, 47.601288664869394 ], [ -122.310601403319964, 47.601290468292149 ], [ -122.310933022520899, 47.601319650781825 ], [ -122.310929472151088, 47.602036825480539 ], [ -122.310751123410711, 47.602212009424207 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.310752531035561, 47.603960727447706 ], [ -122.31074710824339, 47.605247531381522 ], [ -122.309613682051165, 47.605267675721322 ], [ -122.309615346533619, 47.603990185448438 ], [ -122.30985455374298, 47.603963521943598 ], [ -122.310470379799753, 47.603932040750635 ], [ -122.310734113183926, 47.603938227569159 ], [ -122.310752531035561, 47.603960727447706 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.310735510362974, 47.603088044127141 ], [ -122.310489167237151, 47.603094278428507 ], [ -122.30987466584827, 47.603068361100156 ], [ -122.309625197772178, 47.603041991651878 ], [ -122.309624082166138, 47.602146457486583 ], [ -122.310751123410711, 47.602212009424207 ], [ -122.31074624124598, 47.603075325096498 ], [ -122.310735510362974, 47.603088044127141 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.310306920035146, 47.600846879546602 ], [ -122.31026855195671, 47.600847202986671 ], [ -122.309947536025419, 47.60040652981445 ], [ -122.310597166866899, 47.600405704362302 ], [ -122.310306920035146, 47.600846879546602 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.309621567051835, 47.601317573419394 ], [ -122.309586839896696, 47.601264881205992 ], [ -122.309590150908548, 47.60043143330028 ], [ -122.309624363522303, 47.60038046440166 ], [ -122.309947536025419, 47.60040652981445 ], [ -122.31026855195671, 47.600847202986671 ], [ -122.309981888396479, 47.601288664869394 ], [ -122.309621567051835, 47.601317573419394 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.310601403319964, 47.601290468292149 ], [ -122.309981888396479, 47.601288664869394 ], [ -122.31026855195671, 47.600847202986671 ], [ -122.310306920035146, 47.600846879546602 ], [ -122.310601403319964, 47.601290468292149 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.310290476706342, 47.597908044653209 ], [ -122.309261330445054, 47.597910900633423 ], [ -122.309200555058084, 47.597904978568451 ], [ -122.308992197333609, 47.597482393887887 ], [ -122.310291728914649, 47.597086266487437 ], [ -122.310290476706342, 47.597908044653209 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.310734113183926, 47.603938227569159 ], [ -122.310470379799753, 47.603932040750635 ], [ -122.310207534258211, 47.603520995063342 ], [ -122.310489167237151, 47.603094278428507 ], [ -122.310735510362974, 47.603088044127141 ], [ -122.310734113183926, 47.603938227569159 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.309542395176791, 47.605274819380369 ], [ -122.308965093037486, 47.604330143152254 ], [ -122.309248139903971, 47.603930974494325 ], [ -122.309576339810917, 47.603935558745178 ], [ -122.309615346533619, 47.603990185448438 ], [ -122.309613682051165, 47.605267675721322 ], [ -122.309600284983034, 47.6052768203391 ], [ -122.309542395176791, 47.605274819380369 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.309600284983034, 47.6052768203391 ], [ -122.30959849487644, 47.607100801280652 ], [ -122.309598424408193, 47.607100850660714 ], [ -122.308293820117569, 47.607098586214128 ], [ -122.308298235446472, 47.605272491639262 ], [ -122.308308586284141, 47.605265710267879 ], [ -122.309542395176791, 47.605274819380369 ], [ -122.309600284983034, 47.6052768203391 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.309615346533619, 47.603990185448438 ], [ -122.309576339810917, 47.603935558745178 ], [ -122.309574067397037, 47.603110159374459 ], [ -122.309625197772178, 47.603041991651878 ], [ -122.30987466584827, 47.603068361100156 ], [ -122.310177590438585, 47.603519455327024 ], [ -122.30985455374298, 47.603963521943598 ], [ -122.309615346533619, 47.603990185448438 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.30985455374298, 47.603963521943598 ], [ -122.310177590438585, 47.603519455327024 ], [ -122.310207534258211, 47.603520995063342 ], [ -122.310470379799753, 47.603932040750635 ], [ -122.30985455374298, 47.603963521943598 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.310489167237151, 47.603094278428507 ], [ -122.310207534258211, 47.603520995063342 ], [ -122.310177590438585, 47.603519455327024 ], [ -122.30987466584827, 47.603068361100156 ], [ -122.310489167237151, 47.603094278428507 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.309625197772178, 47.603041991651878 ], [ -122.309574067397037, 47.603110159374459 ], [ -122.309267396056512, 47.603106325069781 ], [ -122.309226254570802, 47.603103123298062 ], [ -122.308978238310317, 47.6026783440674 ], [ -122.309305266437235, 47.602161183308631 ], [ -122.309619275448085, 47.602140383030985 ], [ -122.309624082166138, 47.602146457486583 ], [ -122.309625197772178, 47.603041991651878 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.309621567051835, 47.601317573419394 ], [ -122.309619275448085, 47.602140383030985 ], [ -122.309305266437235, 47.602161183308631 ], [ -122.308510555855804, 47.602159857962647 ], [ -122.308320286482484, 47.602150124930461 ], [ -122.308315196480578, 47.60214389050649 ], [ -122.308314439065796, 47.601260469486235 ], [ -122.309586839896696, 47.601264881205992 ], [ -122.309621567051835, 47.601317573419394 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.047619047619047616 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.30973506002077, 47.598686932457149 ], [ -122.309623791300794, 47.599023930857193 ], [ -122.30831016479496, 47.599019780378498 ], [ -122.308187729069346, 47.59866265570458 ], [ -122.308777249864278, 47.598583829487524 ], [ -122.309162741740224, 47.598589696256873 ], [ -122.30973506002077, 47.598686932457149 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.309576339810917, 47.603935558745178 ], [ -122.309248139903971, 47.603930974494325 ], [ -122.309231384168427, 47.603929658111433 ], [ -122.308974266992848, 47.603521657803036 ], [ -122.309267396056512, 47.603106325069781 ], [ -122.309574067397037, 47.603110159374459 ], [ -122.309576339810917, 47.603935558745178 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.309162741740224, 47.598589696256873 ], [ -122.308777249864278, 47.598583829487524 ], [ -122.308954156178828, 47.598324761662781 ], [ -122.308992626670886, 47.598323194636627 ], [ -122.309162741740224, 47.598589696256873 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.309624363522303, 47.60038046440166 ], [ -122.309590150908548, 47.60043143330028 ], [ -122.307852747796403, 47.600418334162427 ], [ -122.308312673975834, 47.59962700215678 ], [ -122.309626480631351, 47.599625285884215 ], [ -122.309624363522303, 47.60038046440166 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.309626480631351, 47.599625285884215 ], [ -122.308312673975834, 47.59962700215678 ], [ -122.30831016479496, 47.599019780378498 ], [ -122.309623791300794, 47.599023930857193 ], [ -122.309627153509112, 47.59962413047991 ], [ -122.309626480631351, 47.599625285884215 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.309231384168427, 47.603929658111433 ], [ -122.309248139903971, 47.603930974494325 ], [ -122.308965093037486, 47.604330143152254 ], [ -122.308938224894675, 47.604329776212509 ], [ -122.30866293563848, 47.603923954664673 ], [ -122.308667310857032, 47.603923716488431 ], [ -122.309231384168427, 47.603929658111433 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.308667310857032, 47.603923716488431 ], [ -122.308946613359623, 47.60352126331469 ], [ -122.308974266992848, 47.603521657803036 ], [ -122.309231384168427, 47.603929658111433 ], [ -122.308667310857032, 47.603923716488431 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.309542395176791, 47.605274819380369 ], [ -122.308308586284141, 47.605265710267879 ], [ -122.308309477595103, 47.605236696559707 ], [ -122.308938224894675, 47.604329776212509 ], [ -122.308965093037486, 47.604330143152254 ], [ -122.309542395176791, 47.605274819380369 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.309586839896696, 47.601264881205992 ], [ -122.308314439065796, 47.601260469486235 ], [ -122.307796069221709, 47.600464562880198 ], [ -122.307852747796403, 47.600418334162427 ], [ -122.309590150908548, 47.60043143330028 ], [ -122.309586839896696, 47.601264881205992 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.309261330445054, 47.597910900633423 ], [ -122.308992626670886, 47.598323194636627 ], [ -122.308954156178828, 47.598324761662781 ], [ -122.308631369769202, 47.597902065173919 ], [ -122.309200555058084, 47.597904978568451 ], [ -122.309261330445054, 47.597910900633423 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.309200555058084, 47.597904978568451 ], [ -122.308631369769202, 47.597902065173919 ], [ -122.30784310359023, 47.597832664342313 ], [ -122.308992197333609, 47.597482393887887 ], [ -122.309200555058084, 47.597904978568451 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.308187729069346, 47.59866265570458 ], [ -122.307621989390313, 47.597900065084623 ], [ -122.30784310359023, 47.597832664342313 ], [ -122.308631369769202, 47.597902065173919 ], [ -122.308954156178828, 47.598324761662781 ], [ -122.308777249864278, 47.598583829487524 ], [ -122.308187729069346, 47.59866265570458 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.12727272727272726 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.30831016479496, 47.599019780378498 ], [ -122.308312673975834, 47.59962700215678 ], [ -122.307852747796403, 47.600418334162427 ], [ -122.307796069221709, 47.600464562880198 ], [ -122.307597533799381, 47.600465835752402 ], [ -122.306465874783214, 47.598691181874493 ], [ -122.306466400000019, 47.5984007 ], [ -122.3064717, 47.5982507 ], [ -122.307621989390313, 47.597900065084623 ], [ -122.308187729069346, 47.59866265570458 ], [ -122.30831016479496, 47.599019780378498 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.309226254570802, 47.603103123298062 ], [ -122.308660250157445, 47.603102754277053 ], [ -122.308946388653027, 47.602680756920229 ], [ -122.308978238310317, 47.6026783440674 ], [ -122.309226254570802, 47.603103123298062 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.309267396056512, 47.603106325069781 ], [ -122.308974266992848, 47.603521657803036 ], [ -122.308946613359623, 47.60352126331469 ], [ -122.308656306317729, 47.603103024356059 ], [ -122.308660250157445, 47.603102754277053 ], [ -122.309226254570802, 47.603103123298062 ], [ -122.309267396056512, 47.603106325069781 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.308318363003593, 47.603089263497971 ], [ -122.307983848085428, 47.603093118189143 ], [ -122.307955132086462, 47.603090879103476 ], [ -122.307689630743155, 47.602677494887637 ], [ -122.308016746663981, 47.602161844175008 ], [ -122.308315196480578, 47.60214389050649 ], [ -122.308320286482484, 47.602150124930461 ], [ -122.308318363003593, 47.603089263497971 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.308320286482484, 47.602150124930461 ], [ -122.308510555855804, 47.602159857962647 ], [ -122.308946388653027, 47.602680756920229 ], [ -122.308660250157445, 47.603102754277053 ], [ -122.308656306317729, 47.603103024356059 ], [ -122.308329339485169, 47.603104620265611 ], [ -122.308318363003593, 47.603089263497971 ], [ -122.308320286482484, 47.602150124930461 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.308978238310317, 47.6026783440674 ], [ -122.308946388653027, 47.602680756920229 ], [ -122.308510555855804, 47.602159857962647 ], [ -122.309305266437235, 47.602161183308631 ], [ -122.308978238310317, 47.6026783440674 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.055555555555555552 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.308315196480578, 47.60214389050649 ], [ -122.308016746663981, 47.602161844175008 ], [ -122.307285459945078, 47.602158786956281 ], [ -122.306459693201333, 47.602110031976331 ], [ -122.306461188449163, 47.601283054623359 ], [ -122.307597533799381, 47.600465835752402 ], [ -122.307796069221709, 47.600464562880198 ], [ -122.308314439065796, 47.601260469486235 ], [ -122.308315196480578, 47.60214389050649 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.308667310857032, 47.603923716488431 ], [ -122.30866293563848, 47.603923954664673 ], [ -122.308322827309127, 47.603921303158089 ], [ -122.308329339485169, 47.603104620265611 ], [ -122.308656306317729, 47.603103024356059 ], [ -122.308946613359623, 47.60352126331469 ], [ -122.308667310857032, 47.603923716488431 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.308938224894675, 47.604329776212509 ], [ -122.308309477595103, 47.605236696559707 ], [ -122.30831467254022, 47.60393287586659 ], [ -122.308322827309127, 47.603921303158089 ], [ -122.30866293563848, 47.603923954664673 ], [ -122.308938224894675, 47.604329776212509 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.308308586284141, 47.605265710267879 ], [ -122.308298235446472, 47.605272491639262 ], [ -122.308201381061735, 47.605268915106784 ], [ -122.307684106053912, 47.60432029676987 ], [ -122.307985539717535, 47.603924938124095 ], [ -122.30831467254022, 47.60393287586659 ], [ -122.308309477595103, 47.605236696559707 ], [ -122.308308586284141, 47.605265710267879 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.307089591882672, 47.605261580195496 ], [ -122.308201381061735, 47.605268915106784 ], [ -122.308298235446472, 47.605272491639262 ], [ -122.308293820117569, 47.607098586214128 ], [ -122.307414796014044, 47.607707339084676 ], [ -122.306452199999981, 47.6062543 ], [ -122.30645397130435, 47.605274643953386 ], [ -122.307089591882672, 47.605261580195496 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.308322827309127, 47.603921303158089 ], [ -122.30831467254022, 47.60393287586659 ], [ -122.307985539717535, 47.603924938124095 ], [ -122.307940636371711, 47.603920635832836 ], [ -122.307692636987284, 47.60350905 ], [ -122.307983848085428, 47.603093118189143 ], [ -122.308318363003593, 47.603089263497971 ], [ -122.308329339485169, 47.603104620265611 ], [ -122.308322827309127, 47.603921303158089 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.307955132086462, 47.603090879103476 ], [ -122.307375957620238, 47.603090101688089 ], [ -122.307656716381771, 47.60267911567059 ], [ -122.307689630743155, 47.602677494887637 ], [ -122.307955132086462, 47.603090879103476 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.307983848085428, 47.603093118189143 ], [ -122.307692636987284, 47.60350905 ], [ -122.30765599036981, 47.60350905 ], [ -122.307337943182048, 47.60309289551445 ], [ -122.307375957620238, 47.603090101688089 ], [ -122.307955132086462, 47.603090879103476 ], [ -122.307983848085428, 47.603093118189143 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.307940636371711, 47.603920635832836 ], [ -122.307985539717535, 47.603924938124095 ], [ -122.307684106053912, 47.60432029676987 ], [ -122.307654848881299, 47.604319485197813 ], [ -122.307333502938988, 47.603922573345002 ], [ -122.307388050973486, 47.603918209219323 ], [ -122.307940636371711, 47.603920635832836 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.307388050973486, 47.603918209219323 ], [ -122.30765599036981, 47.60350905 ], [ -122.307692636987284, 47.60350905 ], [ -122.307940636371711, 47.603920635832836 ], [ -122.307388050973486, 47.603918209219323 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.308201381061735, 47.605268915106784 ], [ -122.307089591882672, 47.605261580195496 ], [ -122.307654848881299, 47.604319485197813 ], [ -122.307684106053912, 47.60432029676987 ], [ -122.308201381061735, 47.605268915106784 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.095238095238095233 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.307656716381771, 47.60267911567059 ], [ -122.307375957620238, 47.603090101688089 ], [ -122.307337943182048, 47.60309289551445 ], [ -122.3064579298225, 47.603085304648047 ], [ -122.306459693201333, 47.602110031976331 ], [ -122.307285459945078, 47.602158786956281 ], [ -122.307656716381771, 47.60267911567059 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.307285459945078, 47.602158786956281 ], [ -122.308016746663981, 47.602161844175008 ], [ -122.307689630743155, 47.602677494887637 ], [ -122.307656716381771, 47.60267911567059 ], [ -122.307285459945078, 47.602158786956281 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.13333333333333333 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.307654848881299, 47.604319485197813 ], [ -122.307089591882672, 47.605261580195496 ], [ -122.30645397130435, 47.605274643953386 ], [ -122.306456397052614, 47.603933034339818 ], [ -122.307333502938988, 47.603922573345002 ], [ -122.307654848881299, 47.604319485197813 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.095238095238095233 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.307333502938988, 47.603922573345002 ], [ -122.306456397052614, 47.603933034339818 ], [ -122.3064579298225, 47.603085304648047 ], [ -122.307337943182048, 47.60309289551445 ], [ -122.30765599036981, 47.60350905 ], [ -122.307388050973486, 47.603918209219323 ], [ -122.307333502938988, 47.603922573345002 ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ -122.307597533799381, 47.600465835752402 ], [ -122.306461188449163, 47.601283054623359 ], [ -122.306465874783214, 47.598691181874493 ], [ -122.307597533799381, 47.600465835752402 ] ] ] } } +] +} diff --git a/tests/xnqm/outputs/p14_scores_polygon.geojson b/tests/xnqm/outputs/p14_scores_polygon.geojson new file mode 100644 index 0000000..d1e4207 --- /dev/null +++ b/tests/xnqm/outputs/p14_scores_polygon.geojson @@ -0,0 +1,459 @@ +{ +"type": "FeatureCollection", +"crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:OGC:1.3:CRS84" } }, +"features": [ +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323713, 47.608609 ], [ -122.32372, 47.60861 ], [ -122.32391, 47.608844 ], [ -122.323138, 47.609272 ], [ -122.322387, 47.609542 ], [ -122.32315, 47.608848 ], [ -122.323713, 47.608609 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320401, 47.603958 ], [ -122.320771, 47.604408 ], [ -122.320359, 47.604821 ], [ -122.320312, 47.604791 ], [ -122.320339, 47.603985 ], [ -122.320401, 47.603958 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310931, 47.601813 ], [ -122.310933, 47.60132 ], [ -122.310968, 47.601269 ], [ -122.312232, 47.601276 ], [ -122.312231, 47.601886 ], [ -122.310945, 47.601896 ], [ -122.310931, 47.601813 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324736, 47.606998 ], [ -122.324448, 47.606327 ], [ -122.32476, 47.606039 ], [ -122.32497, 47.606016 ], [ -122.325284, 47.606767 ], [ -122.325069, 47.606965 ], [ -122.324736, 47.606998 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314773, 47.60698 ], [ -122.316129, 47.606995 ], [ -122.316127, 47.607322 ], [ -122.314634, 47.607302 ], [ -122.314773, 47.60698 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311582, 47.598331 ], [ -122.311396, 47.5981 ], [ -122.311772, 47.598102 ], [ -122.311617, 47.598333 ], [ -122.311582, 47.598331 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310146, 47.601289 ], [ -122.310144, 47.601803 ], [ -122.309907, 47.602076 ], [ -122.309872, 47.602093 ], [ -122.309875, 47.601206 ], [ -122.310013, 47.601241 ], [ -122.310146, 47.601289 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32361, 47.604776 ], [ -122.32393, 47.604767 ], [ -122.32416, 47.605322 ], [ -122.32388, 47.60543 ], [ -122.32361, 47.604776 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309413, 47.599117 ], [ -122.308434, 47.599109 ], [ -122.308697, 47.598893 ], [ -122.309478, 47.59889 ], [ -122.309413, 47.599117 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3223, 47.606352 ], [ -122.322657, 47.606026 ], [ -122.322855, 47.60649 ], [ -122.322519, 47.606886 ], [ -122.3223, 47.606352 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322102, 47.602315 ], [ -122.323365, 47.602292 ], [ -122.323391, 47.602347 ], [ -122.323293, 47.602724 ], [ -122.322625, 47.602926 ], [ -122.322102, 47.602315 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309929, 47.605262 ], [ -122.309614, 47.605154 ], [ -122.309615, 47.604075 ], [ -122.309639, 47.603988 ], [ -122.309855, 47.603964 ], [ -122.31047, 47.603932 ], [ -122.310752, 47.604094 ], [ -122.310747, 47.605248 ], [ -122.309929, 47.605262 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310958, 47.603948 ], [ -122.310958, 47.603297 ], [ -122.311113, 47.603317 ], [ -122.311259, 47.603521 ], [ -122.310972, 47.603947 ], [ -122.310958, 47.603948 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325985, 47.60332 ], [ -122.327287, 47.602417 ], [ -122.327618, 47.602835 ], [ -122.326569, 47.603794 ], [ -122.326372, 47.603792 ], [ -122.325985, 47.60332 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311259, 47.603521 ], [ -122.311288, 47.60352 ], [ -122.311533, 47.603905 ], [ -122.311421, 47.603947 ], [ -122.310972, 47.603947 ], [ -122.311259, 47.603521 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32356, 47.607202 ], [ -122.324014, 47.607376 ], [ -122.323999, 47.607452 ], [ -122.32375, 47.607679 ], [ -122.323551, 47.6078 ], [ -122.323081, 47.607732 ], [ -122.323296, 47.607443 ], [ -122.32356, 47.607202 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.46666666666666667 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317627, 47.601919 ], [ -122.318035, 47.601528 ], [ -122.318043, 47.601755 ], [ -122.317954, 47.601862 ], [ -122.317617, 47.602138 ], [ -122.317627, 47.601919 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.46666666666666667 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32088, 47.603878 ], [ -122.321021, 47.604405 ], [ -122.320771, 47.604408 ], [ -122.320401, 47.603958 ], [ -122.32049, 47.603883 ], [ -122.32088, 47.603878 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326098, 47.605523 ], [ -122.326533, 47.605129 ], [ -122.326558, 47.605139 ], [ -122.326987, 47.606153 ], [ -122.326756, 47.606444 ], [ -122.326459, 47.606377 ], [ -122.326098, 47.605523 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323999, 47.607452 ], [ -122.324231, 47.608012 ], [ -122.323973, 47.608213 ], [ -122.32375, 47.607679 ], [ -122.323999, 47.607452 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314638, 47.603942 ], [ -122.313571, 47.603931 ], [ -122.313575, 47.603262 ], [ -122.31464, 47.603263 ], [ -122.314638, 47.603942 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.045454545454545456 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311172, 47.599646 ], [ -122.311278, 47.599808 ], [ -122.311275, 47.600115 ], [ -122.31122, 47.600296 ], [ -122.311127, 47.600441 ], [ -122.310983, 47.600647 ], [ -122.310971, 47.600656 ], [ -122.31083, 47.600551 ], [ -122.310629, 47.600222 ], [ -122.31063, 47.599798 ], [ -122.310785, 47.599531 ], [ -122.311172, 47.599646 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.083333333333333329 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312231, 47.602395 ], [ -122.312234, 47.602182 ], [ -122.312261, 47.601981 ], [ -122.313263, 47.601977 ], [ -122.313531, 47.60233 ], [ -122.31353, 47.602394 ], [ -122.313071, 47.602455 ], [ -122.312716, 47.602456 ], [ -122.312231, 47.602395 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315891, 47.605828 ], [ -122.316153, 47.606009 ], [ -122.316149, 47.60683 ], [ -122.316131, 47.60685 ], [ -122.31596, 47.606692 ], [ -122.315774, 47.606374 ], [ -122.315775, 47.606028 ], [ -122.315891, 47.605828 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313123, 47.6031 ], [ -122.313154, 47.603098 ], [ -122.31351, 47.603099 ], [ -122.313575, 47.603262 ], [ -122.313571, 47.603931 ], [ -122.313568, 47.603935 ], [ -122.313226, 47.603932 ], [ -122.312899, 47.603517 ], [ -122.313123, 47.6031 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.083333333333333329 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31091, 47.606774 ], [ -122.312203, 47.606785 ], [ -122.312206, 47.606789 ], [ -122.312203, 47.607393 ], [ -122.31217, 47.607426 ], [ -122.311842, 47.607705 ], [ -122.311216, 47.607709 ], [ -122.310614, 47.607094 ], [ -122.31091, 47.606774 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319146, 47.598757 ], [ -122.319306, 47.598714 ], [ -122.319423, 47.598772 ], [ -122.319424, 47.599706 ], [ -122.319146, 47.59968 ], [ -122.319146, 47.598757 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314815, 47.608947 ], [ -122.314686, 47.608636 ], [ -122.314818, 47.608363 ], [ -122.315775, 47.608362 ], [ -122.315999, 47.608585 ], [ -122.316021, 47.608664 ], [ -122.315738, 47.608946 ], [ -122.314815, 47.608947 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314395, 47.599723 ], [ -122.3143, 47.599617 ], [ -122.314499, 47.599216 ], [ -122.314862, 47.599383 ], [ -122.314726, 47.599765 ], [ -122.314395, 47.599723 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314962, 47.598766 ], [ -122.31543, 47.598692 ], [ -122.315671, 47.598869 ], [ -122.315055, 47.599349 ], [ -122.314959, 47.598767 ], [ -122.314962, 47.598766 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.19047619047619047 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315999, 47.608585 ], [ -122.315775, 47.608362 ], [ -122.315777, 47.607775 ], [ -122.316139, 47.607382 ], [ -122.316169, 47.607426 ], [ -122.316166, 47.608375 ], [ -122.315999, 47.608585 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.083333333333333329 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314627, 47.607311 ], [ -122.313716, 47.60731 ], [ -122.313395, 47.606784 ], [ -122.313481, 47.606487 ], [ -122.314826, 47.606488 ], [ -122.314829, 47.606699 ], [ -122.314773, 47.60698 ], [ -122.314634, 47.607302 ], [ -122.314627, 47.607311 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324725, 47.598777 ], [ -122.325372, 47.598781 ], [ -122.32537, 47.599443 ], [ -122.32472, 47.599439 ], [ -122.324722, 47.598779 ], [ -122.324725, 47.598777 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325413, 47.599768 ], [ -122.325492, 47.59961 ], [ -122.326033, 47.599613 ], [ -122.326031, 47.600458 ], [ -122.325497, 47.60087 ], [ -122.325363, 47.60087 ], [ -122.325366, 47.599935 ], [ -122.325413, 47.599768 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314966, 47.597837 ], [ -122.315297, 47.597645 ], [ -122.315434, 47.597799 ], [ -122.31543, 47.598692 ], [ -122.314962, 47.598766 ], [ -122.314966, 47.597837 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324065, 47.599947 ], [ -122.322904, 47.599955 ], [ -122.323091, 47.59978 ], [ -122.324098, 47.599799 ], [ -122.324065, 47.599947 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316169, 47.607426 ], [ -122.316139, 47.607382 ], [ -122.31614, 47.607369 ], [ -122.317591, 47.60736 ], [ -122.317423, 47.607817 ], [ -122.316516, 47.607823 ], [ -122.316169, 47.607426 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321826, 47.606435 ], [ -122.321812, 47.606736 ], [ -122.32135, 47.60677 ], [ -122.321184, 47.60639 ], [ -122.321826, 47.606435 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.083333333333333329 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323081, 47.607732 ], [ -122.323551, 47.6078 ], [ -122.3238, 47.608395 ], [ -122.32372, 47.60861 ], [ -122.323713, 47.608609 ], [ -122.323047, 47.608104 ], [ -122.322935, 47.607825 ], [ -122.322937, 47.607785 ], [ -122.323081, 47.607732 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31482, 47.607762 ], [ -122.314818, 47.608363 ], [ -122.314686, 47.608636 ], [ -122.313746, 47.608628 ], [ -122.313513, 47.60846 ], [ -122.313515, 47.607709 ], [ -122.313716, 47.60731 ], [ -122.314627, 47.607311 ], [ -122.31482, 47.607762 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310178, 47.60352 ], [ -122.309855, 47.603964 ], [ -122.309639, 47.603988 ], [ -122.309576, 47.603824 ], [ -122.309574, 47.60311 ], [ -122.309625, 47.603042 ], [ -122.309875, 47.603068 ], [ -122.310178, 47.60352 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32135, 47.60677 ], [ -122.321072, 47.607024 ], [ -122.32094, 47.606639 ], [ -122.321092, 47.606357 ], [ -122.321106, 47.606346 ], [ -122.321184, 47.60639 ], [ -122.32135, 47.60677 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32201, 47.605286 ], [ -122.322216, 47.605777 ], [ -122.3218, 47.606158 ], [ -122.321306, 47.605663 ], [ -122.321303, 47.605645 ], [ -122.321665, 47.605315 ], [ -122.32201, 47.605286 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31727, 47.606691 ], [ -122.316306, 47.606694 ], [ -122.316504, 47.606379 ], [ -122.317109, 47.606377 ], [ -122.31727, 47.606691 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5357142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321496, 47.603135 ], [ -122.321458, 47.602777 ], [ -122.321459, 47.602437 ], [ -122.321895, 47.602179 ], [ -122.322102, 47.602315 ], [ -122.322625, 47.602926 ], [ -122.322132, 47.603374 ], [ -122.321496, 47.603135 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316581, 47.601584 ], [ -122.316581, 47.60188 ], [ -122.316281, 47.60218 ], [ -122.316237, 47.602174 ], [ -122.316239, 47.601053 ], [ -122.316389, 47.601202 ], [ -122.316532, 47.601458 ], [ -122.316581, 47.601584 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316127, 47.607322 ], [ -122.31614, 47.607369 ], [ -122.316139, 47.607382 ], [ -122.315777, 47.607775 ], [ -122.31482, 47.607762 ], [ -122.314627, 47.607311 ], [ -122.314634, 47.607302 ], [ -122.316127, 47.607322 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.30913, 47.603769 ], [ -122.308974, 47.603522 ], [ -122.309267, 47.603106 ], [ -122.309574, 47.60311 ], [ -122.309576, 47.603824 ], [ -122.30913, 47.603769 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321106, 47.606346 ], [ -122.321118, 47.606079 ], [ -122.321306, 47.605663 ], [ -122.3218, 47.606158 ], [ -122.32184, 47.606404 ], [ -122.321826, 47.606435 ], [ -122.321184, 47.60639 ], [ -122.321106, 47.606346 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31141, 47.598588 ], [ -122.310965, 47.598632 ], [ -122.310741, 47.598549 ], [ -122.310623, 47.598385 ], [ -122.311039, 47.598048 ], [ -122.311396, 47.5981 ], [ -122.311582, 47.598331 ], [ -122.31141, 47.598588 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7142857142857143 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326031, 47.600458 ], [ -122.326033, 47.599613 ], [ -122.326037, 47.599611 ], [ -122.326386, 47.599613 ], [ -122.326696, 47.600004 ], [ -122.326694, 47.600458 ], [ -122.326031, 47.600458 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.18181818181818182 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313481, 47.606487 ], [ -122.313395, 47.606784 ], [ -122.312206, 47.606789 ], [ -122.312203, 47.606785 ], [ -122.312211, 47.605275 ], [ -122.312298, 47.605274 ], [ -122.313242, 47.605291 ], [ -122.313431, 47.605694 ], [ -122.313511, 47.606011 ], [ -122.31351, 47.606302 ], [ -122.313481, 47.606487 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310459, 47.600616 ], [ -122.31083, 47.600551 ], [ -122.310971, 47.600656 ], [ -122.310968, 47.601269 ], [ -122.310933, 47.60132 ], [ -122.310601, 47.601291 ], [ -122.310307, 47.600847 ], [ -122.310459, 47.600616 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310989, 47.602162 ], [ -122.310925, 47.602129 ], [ -122.310921, 47.602091 ], [ -122.310945, 47.601896 ], [ -122.312231, 47.601886 ], [ -122.312261, 47.601981 ], [ -122.312234, 47.602182 ], [ -122.310989, 47.602162 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320499, 47.603202 ], [ -122.321435, 47.603192 ], [ -122.321266, 47.603649 ], [ -122.32088, 47.603878 ], [ -122.32049, 47.603883 ], [ -122.320499, 47.603202 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3097, 47.607193 ], [ -122.308222, 47.607221 ], [ -122.308188, 47.607178 ], [ -122.308315, 47.606596 ], [ -122.309355, 47.606602 ], [ -122.309853, 47.607103 ], [ -122.3097, 47.607193 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.045454545454545456 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318246, 47.600688 ], [ -122.318153, 47.600572 ], [ -122.318146, 47.600498 ], [ -122.318145, 47.600411 ], [ -122.318165, 47.600138 ], [ -122.318447, 47.599806 ], [ -122.318992, 47.599686 ], [ -122.319146, 47.59968 ], [ -122.319424, 47.599706 ], [ -122.319614, 47.599806 ], [ -122.318444, 47.600803 ], [ -122.318246, 47.600688 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314377, 47.59703 ], [ -122.314936, 47.596672 ], [ -122.315297, 47.597195 ], [ -122.315297, 47.597645 ], [ -122.314966, 47.597837 ], [ -122.314443, 47.598008 ], [ -122.314378, 47.597964 ], [ -122.314377, 47.59703 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317625, 47.598744 ], [ -122.316711, 47.598743 ], [ -122.316783, 47.59845 ], [ -122.317509, 47.598451 ], [ -122.317625, 47.598744 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313265, 47.601357 ], [ -122.313055, 47.601272 ], [ -122.313058, 47.600318 ], [ -122.313675, 47.600545 ], [ -122.313673, 47.601155 ], [ -122.313265, 47.601357 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325775, 47.605582 ], [ -122.326098, 47.605523 ], [ -122.326459, 47.606377 ], [ -122.32597, 47.606505 ], [ -122.325868, 47.606509 ], [ -122.325559, 47.60578 ], [ -122.325775, 47.605582 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311426, 47.603315 ], [ -122.311288, 47.60352 ], [ -122.311259, 47.603521 ], [ -122.311113, 47.603317 ], [ -122.311426, 47.603315 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31221, 47.597378 ], [ -122.312695, 47.597843 ], [ -122.312707, 47.597975 ], [ -122.312192, 47.598411 ], [ -122.311981, 47.598069 ], [ -122.311977, 47.597772 ], [ -122.31221, 47.597378 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321588, 47.608315 ], [ -122.320014, 47.608325 ], [ -122.320083, 47.608025 ], [ -122.320135, 47.607998 ], [ -122.321449, 47.607923 ], [ -122.321588, 47.608315 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.41666666666666669 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322625, 47.602926 ], [ -122.323293, 47.602724 ], [ -122.323689, 47.603663 ], [ -122.323689, 47.60367 ], [ -122.32344, 47.603899 ], [ -122.322444, 47.603916 ], [ -122.322225, 47.603593 ], [ -122.322132, 47.603374 ], [ -122.322625, 47.602926 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311275, 47.600115 ], [ -122.31243, 47.600093 ], [ -122.312439, 47.600117 ], [ -122.312344, 47.600307 ], [ -122.31122, 47.600296 ], [ -122.311275, 47.600115 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311419, 47.602466 ], [ -122.31142, 47.602917 ], [ -122.310747, 47.602917 ], [ -122.310749, 47.602516 ], [ -122.310925, 47.602129 ], [ -122.310989, 47.602162 ], [ -122.311419, 47.602466 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317779, 47.605708 ], [ -122.317782, 47.604783 ], [ -122.318182, 47.604784 ], [ -122.318192, 47.604786 ], [ -122.318188, 47.605707 ], [ -122.317782, 47.60571 ], [ -122.317779, 47.605708 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325945, 47.603293 ], [ -122.324715, 47.604413 ], [ -122.324492, 47.604251 ], [ -122.324341, 47.604064 ], [ -122.325423, 47.60274 ], [ -122.325543, 47.602786 ], [ -122.325673, 47.602907 ], [ -122.325945, 47.603293 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321351, 47.601279 ], [ -122.321542, 47.601272 ], [ -122.322015, 47.601366 ], [ -122.322018, 47.601945 ], [ -122.321895, 47.602179 ], [ -122.321459, 47.602437 ], [ -122.321151, 47.602199 ], [ -122.321158, 47.601358 ], [ -122.321351, 47.601279 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320891, 47.600802 ], [ -122.321357, 47.600795 ], [ -122.321351, 47.601279 ], [ -122.321158, 47.601358 ], [ -122.320885, 47.60122 ], [ -122.320891, 47.600802 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320353, 47.60308 ], [ -122.320499, 47.603202 ], [ -122.32049, 47.603883 ], [ -122.320401, 47.603958 ], [ -122.320339, 47.603985 ], [ -122.320132, 47.603949 ], [ -122.320143, 47.603116 ], [ -122.320353, 47.60308 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319381, 47.603955 ], [ -122.318803, 47.603944 ], [ -122.3188, 47.603941 ], [ -122.31881, 47.603286 ], [ -122.318992, 47.603175 ], [ -122.319252, 47.603109 ], [ -122.319705, 47.603144 ], [ -122.319718, 47.603931 ], [ -122.319381, 47.603955 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313226, 47.603932 ], [ -122.313568, 47.603935 ], [ -122.313561, 47.604955 ], [ -122.313352, 47.60517 ], [ -122.312895, 47.604339 ], [ -122.313187, 47.603934 ], [ -122.313226, 47.603932 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320419, 47.602788 ], [ -122.321458, 47.602777 ], [ -122.321496, 47.603135 ], [ -122.321435, 47.603192 ], [ -122.320499, 47.603202 ], [ -122.320353, 47.60308 ], [ -122.320419, 47.602788 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.307376, 47.60309 ], [ -122.307657, 47.602679 ], [ -122.30769, 47.602678 ], [ -122.307955, 47.603091 ], [ -122.307376, 47.60309 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317527, 47.60859 ], [ -122.317732, 47.608976 ], [ -122.3164, 47.60898 ], [ -122.316307, 47.608831 ], [ -122.3166, 47.608592 ], [ -122.317527, 47.60859 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319424, 47.599706 ], [ -122.319423, 47.598772 ], [ -122.320332, 47.598766 ], [ -122.320331, 47.599883 ], [ -122.320097, 47.600019 ], [ -122.319614, 47.599806 ], [ -122.319424, 47.599706 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32393, 47.604767 ], [ -122.324492, 47.604251 ], [ -122.324715, 47.604413 ], [ -122.324858, 47.60473 ], [ -122.324813, 47.604856 ], [ -122.324316, 47.605308 ], [ -122.32416, 47.605322 ], [ -122.32393, 47.604767 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311421, 47.603947 ], [ -122.311416, 47.605262 ], [ -122.310917, 47.605341 ], [ -122.310747, 47.605248 ], [ -122.310752, 47.604094 ], [ -122.310958, 47.603948 ], [ -122.310972, 47.603947 ], [ -122.311421, 47.603947 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316516, 47.607823 ], [ -122.317423, 47.607817 ], [ -122.317423, 47.608154 ], [ -122.316569, 47.608157 ], [ -122.316515, 47.60811 ], [ -122.316516, 47.607823 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322231, 47.605085 ], [ -122.322573, 47.605046 ], [ -122.322886, 47.605796 ], [ -122.322663, 47.605992 ], [ -122.322216, 47.605777 ], [ -122.32201, 47.605286 ], [ -122.322231, 47.605085 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314726, 47.599765 ], [ -122.314862, 47.599383 ], [ -122.315054, 47.599357 ], [ -122.31511, 47.59943 ], [ -122.31495, 47.599884 ], [ -122.314726, 47.599765 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324174, 47.599569 ], [ -122.32331, 47.599563 ], [ -122.32349, 47.599385 ], [ -122.324086, 47.599389 ], [ -122.324174, 47.599569 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315958, 47.602212 ], [ -122.315886, 47.602182 ], [ -122.315887, 47.600862 ], [ -122.315897, 47.600859 ], [ -122.316101, 47.600839 ], [ -122.316239, 47.601053 ], [ -122.316237, 47.602174 ], [ -122.315958, 47.602212 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312909, 47.609154 ], [ -122.312869, 47.609214 ], [ -122.312841, 47.609214 ], [ -122.312803, 47.609162 ], [ -122.312909, 47.609154 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3091, 47.60414 ], [ -122.308965, 47.60433 ], [ -122.308938, 47.60433 ], [ -122.308807, 47.604136 ], [ -122.3091, 47.60414 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309919, 47.598116 ], [ -122.310154, 47.598229 ], [ -122.310152, 47.599417 ], [ -122.309948, 47.599556 ], [ -122.309919, 47.598116 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318796, 47.604779 ], [ -122.318192, 47.604786 ], [ -122.318182, 47.604784 ], [ -122.318191, 47.603943 ], [ -122.3188, 47.603941 ], [ -122.318803, 47.603944 ], [ -122.318797, 47.604777 ], [ -122.318796, 47.604779 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316306, 47.606694 ], [ -122.31727, 47.606691 ], [ -122.317558, 47.606994 ], [ -122.316131, 47.606986 ], [ -122.316131, 47.60685 ], [ -122.316149, 47.60683 ], [ -122.316306, 47.606694 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1111111111111111 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316472, 47.599261 ], [ -122.31625, 47.600721 ], [ -122.316179, 47.600781 ], [ -122.31616, 47.600791 ], [ -122.316027, 47.599545 ], [ -122.316096, 47.599182 ], [ -122.316109, 47.599164 ], [ -122.316242, 47.599159 ], [ -122.316401, 47.59917 ], [ -122.316472, 47.599261 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32136, 47.604576 ], [ -122.321527, 47.604415 ], [ -122.321965, 47.604448 ], [ -122.322231, 47.605085 ], [ -122.32201, 47.605286 ], [ -122.321665, 47.605315 ], [ -122.32136, 47.604576 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31495, 47.599884 ], [ -122.31511, 47.59943 ], [ -122.315287, 47.599471 ], [ -122.31507, 47.600061 ], [ -122.31495, 47.599884 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313574, 47.602848 ], [ -122.313573, 47.602522 ], [ -122.314566, 47.602449 ], [ -122.314568, 47.602843 ], [ -122.313574, 47.602848 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1111111111111111 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309853, 47.607103 ], [ -122.309355, 47.606602 ], [ -122.309278, 47.606314 ], [ -122.309267, 47.606216 ], [ -122.30927, 47.605273 ], [ -122.309493, 47.605194 ], [ -122.309614, 47.605154 ], [ -122.309929, 47.605262 ], [ -122.309931, 47.607101 ], [ -122.309853, 47.607103 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311902, 47.608721 ], [ -122.311563, 47.609209 ], [ -122.311535, 47.609208 ], [ -122.311192, 47.608752 ], [ -122.311185, 47.608621 ], [ -122.311214, 47.608604 ], [ -122.311839, 47.60861 ], [ -122.311907, 47.608644 ], [ -122.311902, 47.608721 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.066666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315909, 47.59792 ], [ -122.315434, 47.597799 ], [ -122.315297, 47.597645 ], [ -122.315297, 47.597195 ], [ -122.316532, 47.596949 ], [ -122.316621, 47.597081 ], [ -122.316621, 47.597745 ], [ -122.31625, 47.597888 ], [ -122.316092, 47.597918 ], [ -122.315909, 47.59792 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310207, 47.603521 ], [ -122.310178, 47.60352 ], [ -122.309875, 47.603068 ], [ -122.310474, 47.603094 ], [ -122.310472, 47.60312 ], [ -122.310207, 47.603521 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32446, 47.605655 ], [ -122.32476, 47.606039 ], [ -122.324448, 47.606327 ], [ -122.324276, 47.606327 ], [ -122.324124, 47.605965 ], [ -122.32446, 47.605655 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.083333333333333329 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311746, 47.597728 ], [ -122.311977, 47.597772 ], [ -122.311981, 47.598069 ], [ -122.311772, 47.598102 ], [ -122.311396, 47.5981 ], [ -122.311039, 47.598048 ], [ -122.311199, 47.597762 ], [ -122.311447, 47.597726 ], [ -122.311746, 47.597728 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316541, 47.596623 ], [ -122.316532, 47.596949 ], [ -122.315297, 47.597195 ], [ -122.314936, 47.596672 ], [ -122.314935, 47.596204 ], [ -122.31509, 47.596172 ], [ -122.316521, 47.596077 ], [ -122.316541, 47.596623 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.066666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324162, 47.599662 ], [ -122.324197, 47.599606 ], [ -122.324584, 47.599608 ], [ -122.324666, 47.599763 ], [ -122.324716, 47.599931 ], [ -122.324713, 47.600975 ], [ -122.324063, 47.600831 ], [ -122.324065, 47.599947 ], [ -122.324098, 47.599799 ], [ -122.324162, 47.599662 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312925, 47.600215 ], [ -122.313552, 47.599605 ], [ -122.313832, 47.599653 ], [ -122.31383, 47.600437 ], [ -122.313675, 47.600545 ], [ -122.313058, 47.600318 ], [ -122.312925, 47.600215 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317654, 47.598771 ], [ -122.317757, 47.5988 ], [ -122.317763, 47.599771 ], [ -122.317391, 47.599624 ], [ -122.317387, 47.599067 ], [ -122.317654, 47.598771 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323973, 47.608213 ], [ -122.324231, 47.608012 ], [ -122.324799, 47.608114 ], [ -122.324105, 47.608737 ], [ -122.32391, 47.608844 ], [ -122.32372, 47.60861 ], [ -122.3238, 47.608395 ], [ -122.323973, 47.608213 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323548, 47.598753 ], [ -122.324075, 47.598756 ], [ -122.324096, 47.598775 ], [ -122.324069, 47.5992 ], [ -122.323544, 47.599197 ], [ -122.323548, 47.598753 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317301, 47.601111 ], [ -122.317544, 47.601594 ], [ -122.317194, 47.601611 ], [ -122.317181, 47.601269 ], [ -122.317256, 47.601142 ], [ -122.317301, 47.601111 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314829, 47.605721 ], [ -122.314832, 47.604965 ], [ -122.315222, 47.604556 ], [ -122.31547, 47.604507 ], [ -122.315753, 47.604562 ], [ -122.315894, 47.604713 ], [ -122.315889, 47.605712 ], [ -122.314829, 47.605721 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308201, 47.605269 ], [ -122.30709, 47.605262 ], [ -122.307655, 47.60432 ], [ -122.307684, 47.60432 ], [ -122.308201, 47.605269 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318187, 47.603943 ], [ -122.318191, 47.603943 ], [ -122.318182, 47.604784 ], [ -122.317782, 47.604783 ], [ -122.317779, 47.604781 ], [ -122.317783, 47.603943 ], [ -122.318187, 47.603943 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317972, 47.597621 ], [ -122.318401, 47.597155 ], [ -122.318394, 47.598841 ], [ -122.317967, 47.598753 ], [ -122.317972, 47.597621 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322519, 47.606886 ], [ -122.322855, 47.60649 ], [ -122.323374, 47.606657 ], [ -122.32336, 47.606736 ], [ -122.323104, 47.606971 ], [ -122.322554, 47.607303 ], [ -122.322429, 47.607184 ], [ -122.322519, 47.606886 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1111111111111111 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322663, 47.605992 ], [ -122.322886, 47.605796 ], [ -122.322904, 47.605795 ], [ -122.323333, 47.606052 ], [ -122.32346, 47.606354 ], [ -122.323476, 47.606559 ], [ -122.323374, 47.606657 ], [ -122.322855, 47.60649 ], [ -122.322657, 47.606026 ], [ -122.322663, 47.605992 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.307657, 47.602679 ], [ -122.307285, 47.602159 ], [ -122.308017, 47.602162 ], [ -122.30769, 47.602678 ], [ -122.307657, 47.602679 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315774, 47.606374 ], [ -122.314838, 47.606382 ], [ -122.314825, 47.606298 ], [ -122.314826, 47.606042 ], [ -122.314827, 47.606037 ], [ -122.315775, 47.606028 ], [ -122.315774, 47.606374 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311839, 47.60861 ], [ -122.311214, 47.608604 ], [ -122.311216, 47.607709 ], [ -122.311842, 47.607705 ], [ -122.311839, 47.60861 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322653, 47.600293 ], [ -122.322796, 47.60063 ], [ -122.322015, 47.601366 ], [ -122.321542, 47.601272 ], [ -122.321632, 47.600759 ], [ -122.322282, 47.600131 ], [ -122.322653, 47.600293 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31047, 47.603932 ], [ -122.310207, 47.603521 ], [ -122.310472, 47.60312 ], [ -122.31047, 47.603932 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311288, 47.60352 ], [ -122.311426, 47.603315 ], [ -122.311916, 47.603241 ], [ -122.312076, 47.603287 ], [ -122.312076, 47.603747 ], [ -122.311533, 47.603905 ], [ -122.311288, 47.60352 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314805, 47.601717 ], [ -122.314657, 47.60217 ], [ -122.314416, 47.601966 ], [ -122.314403, 47.601602 ], [ -122.314806, 47.601605 ], [ -122.314805, 47.601717 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314386, 47.60044 ], [ -122.31383, 47.600437 ], [ -122.313832, 47.599653 ], [ -122.313908, 47.59961 ], [ -122.3143, 47.599617 ], [ -122.314395, 47.599723 ], [ -122.314386, 47.60044 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313123, 47.6031 ], [ -122.312899, 47.603517 ], [ -122.312867, 47.603519 ], [ -122.312533, 47.603099 ], [ -122.312609, 47.603095 ], [ -122.313123, 47.6031 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1388888888888889 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323091, 47.59978 ], [ -122.322904, 47.599955 ], [ -122.322832, 47.600011 ], [ -122.322731, 47.599105 ], [ -122.322771, 47.598926 ], [ -122.322866, 47.598729 ], [ -122.3232, 47.598762 ], [ -122.323191, 47.599658 ], [ -122.323091, 47.59978 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312203, 47.607393 ], [ -122.312206, 47.606789 ], [ -122.313395, 47.606784 ], [ -122.313716, 47.60731 ], [ -122.313515, 47.607709 ], [ -122.312535, 47.607714 ], [ -122.312203, 47.607393 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324666, 47.599763 ], [ -122.324584, 47.599608 ], [ -122.32472, 47.599439 ], [ -122.32537, 47.599443 ], [ -122.325492, 47.59961 ], [ -122.325413, 47.599768 ], [ -122.324666, 47.599763 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317117, 47.603939 ], [ -122.317116, 47.603938 ], [ -122.317116, 47.603107 ], [ -122.31712, 47.603103 ], [ -122.317784, 47.603112 ], [ -122.317782, 47.603942 ], [ -122.317117, 47.603939 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308296, 47.606215 ], [ -122.308298, 47.605273 ], [ -122.308309, 47.605266 ], [ -122.30927, 47.605273 ], [ -122.309267, 47.606216 ], [ -122.308296, 47.606215 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317301, 47.601111 ], [ -122.317256, 47.601142 ], [ -122.316179, 47.600781 ], [ -122.31625, 47.600721 ], [ -122.316663, 47.600489 ], [ -122.31762, 47.600779 ], [ -122.317301, 47.601111 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308309, 47.605266 ], [ -122.308309, 47.605237 ], [ -122.308938, 47.60433 ], [ -122.308965, 47.60433 ], [ -122.309493, 47.605194 ], [ -122.30927, 47.605273 ], [ -122.308309, 47.605266 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311962, 47.598859 ], [ -122.312204, 47.598696 ], [ -122.312605, 47.599077 ], [ -122.312369, 47.599857 ], [ -122.312303, 47.599833 ], [ -122.311725, 47.599418 ], [ -122.311723, 47.599068 ], [ -122.311962, 47.598859 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320263, 47.606703 ], [ -122.320422, 47.606981 ], [ -122.319983, 47.607784 ], [ -122.319319, 47.607005 ], [ -122.319745, 47.606715 ], [ -122.320263, 47.606703 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319745, 47.603114 ], [ -122.319748, 47.602231 ], [ -122.320168, 47.602029 ], [ -122.320422, 47.602204 ], [ -122.320419, 47.602788 ], [ -122.320353, 47.60308 ], [ -122.320143, 47.603116 ], [ -122.319745, 47.603114 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1111111111111111 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323261, 47.600975 ], [ -122.324063, 47.600831 ], [ -122.324713, 47.600975 ], [ -122.32487, 47.601069 ], [ -122.324867, 47.602201 ], [ -122.323391, 47.602347 ], [ -122.323365, 47.602292 ], [ -122.323256, 47.601947 ], [ -122.323261, 47.600975 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318771, 47.605793 ], [ -122.318188, 47.605707 ], [ -122.318192, 47.604786 ], [ -122.318796, 47.604779 ], [ -122.318793, 47.605767 ], [ -122.318771, 47.605793 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.30769, 47.602678 ], [ -122.308017, 47.602162 ], [ -122.308315, 47.602144 ], [ -122.30832, 47.60215 ], [ -122.308318, 47.603089 ], [ -122.307984, 47.603093 ], [ -122.307955, 47.603091 ], [ -122.30769, 47.602678 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31547, 47.604507 ], [ -122.315472, 47.603174 ], [ -122.315952, 47.603061 ], [ -122.316325, 47.603225 ], [ -122.316325, 47.603936 ], [ -122.315753, 47.604562 ], [ -122.31547, 47.604507 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318035, 47.601528 ], [ -122.317627, 47.601919 ], [ -122.317628, 47.601638 ], [ -122.318038, 47.601203 ], [ -122.318035, 47.601528 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317116, 47.603938 ], [ -122.316325, 47.603936 ], [ -122.316325, 47.603225 ], [ -122.316505, 47.603107 ], [ -122.317116, 47.603107 ], [ -122.317116, 47.603938 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313118, 47.608998 ], [ -122.313119, 47.609597 ], [ -122.312869, 47.609214 ], [ -122.312909, 47.609154 ], [ -122.313118, 47.608998 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320173, 47.601367 ], [ -122.320885, 47.60122 ], [ -122.321158, 47.601358 ], [ -122.321151, 47.602199 ], [ -122.320422, 47.602204 ], [ -122.320168, 47.602029 ], [ -122.320173, 47.601367 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326226, 47.604395 ], [ -122.325431, 47.604774 ], [ -122.324858, 47.60473 ], [ -122.324715, 47.604413 ], [ -122.325945, 47.603293 ], [ -122.325985, 47.60332 ], [ -122.326372, 47.603792 ], [ -122.326226, 47.604395 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32336, 47.606736 ], [ -122.32356, 47.607202 ], [ -122.323296, 47.607443 ], [ -122.323104, 47.606971 ], [ -122.32336, 47.606736 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.30959, 47.600533 ], [ -122.309558, 47.600431 ], [ -122.309625, 47.600223 ], [ -122.310629, 47.600222 ], [ -122.31083, 47.600551 ], [ -122.310459, 47.600616 ], [ -122.3101, 47.600616 ], [ -122.30959, 47.600533 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4642857142857143 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313908, 47.59961 ], [ -122.313907, 47.59925 ], [ -122.314274, 47.598742 ], [ -122.314441, 47.59872 ], [ -122.314496, 47.598765 ], [ -122.314499, 47.599216 ], [ -122.3143, 47.599617 ], [ -122.313908, 47.59961 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315897, 47.600859 ], [ -122.315792, 47.599977 ], [ -122.316027, 47.599545 ], [ -122.31616, 47.600791 ], [ -122.316101, 47.600839 ], [ -122.315897, 47.600859 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322573, 47.605046 ], [ -122.322231, 47.605085 ], [ -122.321965, 47.604448 ], [ -122.322394, 47.604057 ], [ -122.322743, 47.604889 ], [ -122.322573, 47.605046 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314496, 47.598765 ], [ -122.314441, 47.59872 ], [ -122.314443, 47.598008 ], [ -122.314966, 47.597837 ], [ -122.314962, 47.598766 ], [ -122.314959, 47.598767 ], [ -122.314496, 47.598765 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319743, 47.605712 ], [ -122.319747, 47.605714 ], [ -122.319745, 47.606715 ], [ -122.319319, 47.607005 ], [ -122.318769, 47.606995 ], [ -122.318771, 47.605793 ], [ -122.318793, 47.605767 ], [ -122.319371, 47.605711 ], [ -122.319743, 47.605712 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319718, 47.603931 ], [ -122.319705, 47.603144 ], [ -122.319745, 47.603114 ], [ -122.320143, 47.603116 ], [ -122.320132, 47.603949 ], [ -122.319741, 47.603949 ], [ -122.319718, 47.603931 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322743, 47.604889 ], [ -122.322394, 47.604057 ], [ -122.322444, 47.603916 ], [ -122.32344, 47.603899 ], [ -122.323315, 47.604594 ], [ -122.323117, 47.604808 ], [ -122.322743, 47.604889 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324867, 47.602201 ], [ -122.325104, 47.602526 ], [ -122.323689, 47.603663 ], [ -122.323293, 47.602724 ], [ -122.323391, 47.602347 ], [ -122.324867, 47.602201 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308511, 47.60216 ], [ -122.309305, 47.602161 ], [ -122.308978, 47.602678 ], [ -122.308946, 47.602681 ], [ -122.308511, 47.60216 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313076, 47.59898 ], [ -122.313552, 47.599605 ], [ -122.312925, 47.600215 ], [ -122.312439, 47.600117 ], [ -122.31243, 47.600093 ], [ -122.312369, 47.599857 ], [ -122.312605, 47.599077 ], [ -122.312981, 47.598954 ], [ -122.313076, 47.59898 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314416, 47.601966 ], [ -122.313981, 47.601994 ], [ -122.313984, 47.601279 ], [ -122.314303, 47.601274 ], [ -122.314403, 47.601602 ], [ -122.314416, 47.601966 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308807, 47.604136 ], [ -122.308938, 47.60433 ], [ -122.308309, 47.605237 ], [ -122.308314, 47.604061 ], [ -122.308807, 47.604136 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325559, 47.60578 ], [ -122.325868, 47.606509 ], [ -122.325624, 47.60673 ], [ -122.325284, 47.606767 ], [ -122.32497, 47.606016 ], [ -122.325212, 47.605792 ], [ -122.325559, 47.60578 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319371, 47.605711 ], [ -122.318793, 47.605767 ], [ -122.318796, 47.604779 ], [ -122.318797, 47.604777 ], [ -122.319373, 47.604791 ], [ -122.319371, 47.605711 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309626, 47.59987 ], [ -122.309625, 47.600223 ], [ -122.309558, 47.600431 ], [ -122.307765, 47.600418 ], [ -122.307501, 47.600213 ], [ -122.307825, 47.599804 ], [ -122.309572, 47.599808 ], [ -122.309626, 47.59987 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309464, 47.599542 ], [ -122.308019, 47.599559 ], [ -122.308169, 47.59937 ], [ -122.309415, 47.599367 ], [ -122.309464, 47.599542 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317511, 47.597921 ], [ -122.317972, 47.597621 ], [ -122.317967, 47.598753 ], [ -122.317757, 47.5988 ], [ -122.317654, 47.598771 ], [ -122.317625, 47.598744 ], [ -122.317509, 47.598451 ], [ -122.317511, 47.597921 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324727, 47.598159 ], [ -122.324741, 47.598139 ], [ -122.324761, 47.59815 ], [ -122.325451, 47.598717 ], [ -122.325372, 47.598781 ], [ -122.324725, 47.598777 ], [ -122.324727, 47.598159 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308946, 47.602681 ], [ -122.308978, 47.602678 ], [ -122.309226, 47.603103 ], [ -122.30866, 47.603103 ], [ -122.308946, 47.602681 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.13333333333333333 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317289, 47.602202 ], [ -122.317094, 47.601882 ], [ -122.317095, 47.601863 ], [ -122.317194, 47.601611 ], [ -122.317544, 47.601594 ], [ -122.317628, 47.601638 ], [ -122.317627, 47.601919 ], [ -122.317617, 47.602138 ], [ -122.317595, 47.602188 ], [ -122.317289, 47.602202 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310013, 47.601241 ], [ -122.309875, 47.601206 ], [ -122.309588, 47.601042 ], [ -122.30959, 47.600533 ], [ -122.3101, 47.600616 ], [ -122.310269, 47.600847 ], [ -122.310013, 47.601241 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310307, 47.600847 ], [ -122.310601, 47.601291 ], [ -122.310146, 47.601289 ], [ -122.310013, 47.601241 ], [ -122.310269, 47.600847 ], [ -122.310307, 47.600847 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1388888888888889 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315157, 47.600206 ], [ -122.315145, 47.600772 ], [ -122.31491, 47.600775 ], [ -122.314386, 47.60044 ], [ -122.314395, 47.599723 ], [ -122.314726, 47.599765 ], [ -122.31495, 47.599884 ], [ -122.31507, 47.600061 ], [ -122.315157, 47.600206 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322653, 47.600293 ], [ -122.322832, 47.600011 ], [ -122.322904, 47.599955 ], [ -122.324065, 47.599947 ], [ -122.324063, 47.600831 ], [ -122.323261, 47.600975 ], [ -122.322796, 47.60063 ], [ -122.322653, 47.600293 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316542, 47.605389 ], [ -122.317111, 47.60539 ], [ -122.317254, 47.605647 ], [ -122.316541, 47.60565 ], [ -122.316542, 47.605389 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31351, 47.606302 ], [ -122.313511, 47.606011 ], [ -122.314826, 47.606042 ], [ -122.314825, 47.606298 ], [ -122.31351, 47.606302 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.46666666666666667 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313036, 47.598311 ], [ -122.312929, 47.598121 ], [ -122.313568, 47.59756 ], [ -122.313732, 47.597844 ], [ -122.31346, 47.598106 ], [ -122.313036, 47.598311 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321632, 47.600759 ], [ -122.321542, 47.601272 ], [ -122.321351, 47.601279 ], [ -122.321357, 47.600795 ], [ -122.321367, 47.600759 ], [ -122.321632, 47.600759 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3101, 47.600616 ], [ -122.310459, 47.600616 ], [ -122.310307, 47.600847 ], [ -122.310269, 47.600847 ], [ -122.3101, 47.600616 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317254, 47.605647 ], [ -122.317299, 47.605706 ], [ -122.317236, 47.605792 ], [ -122.316542, 47.605793 ], [ -122.316519, 47.60572 ], [ -122.316541, 47.60565 ], [ -122.317254, 47.605647 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321072, 47.607025 ], [ -122.320481, 47.60702 ], [ -122.320422, 47.606981 ], [ -122.320263, 47.606703 ], [ -122.320323, 47.606633 ], [ -122.32094, 47.606639 ], [ -122.321072, 47.607024 ], [ -122.321072, 47.607025 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321496, 47.603135 ], [ -122.322132, 47.603374 ], [ -122.322225, 47.603593 ], [ -122.321506, 47.604203 ], [ -122.321266, 47.603649 ], [ -122.321435, 47.603192 ], [ -122.321496, 47.603135 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325985, 47.60332 ], [ -122.325945, 47.603293 ], [ -122.325673, 47.602907 ], [ -122.32685, 47.602095 ], [ -122.327268, 47.602312 ], [ -122.327287, 47.602417 ], [ -122.325985, 47.60332 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323374, 47.606657 ], [ -122.323476, 47.606559 ], [ -122.323926, 47.60659 ], [ -122.324186, 47.60723 ], [ -122.324014, 47.607376 ], [ -122.32356, 47.607202 ], [ -122.32336, 47.606736 ], [ -122.323374, 47.606657 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311625, 47.597493 ], [ -122.311746, 47.597728 ], [ -122.311447, 47.597726 ], [ -122.311587, 47.597493 ], [ -122.311625, 47.597493 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315305, 47.602222 ], [ -122.315299, 47.60305 ], [ -122.314706, 47.60315 ], [ -122.314568, 47.602843 ], [ -122.314566, 47.602449 ], [ -122.31469, 47.602219 ], [ -122.315305, 47.602222 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31974, 47.604788 ], [ -122.319745, 47.604792 ], [ -122.319743, 47.605712 ], [ -122.319371, 47.605711 ], [ -122.319373, 47.604791 ], [ -122.319378, 47.60479 ], [ -122.31974, 47.604788 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308291, 47.606288 ], [ -122.308296, 47.606215 ], [ -122.309267, 47.606216 ], [ -122.309278, 47.606314 ], [ -122.308291, 47.606288 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326569, 47.603794 ], [ -122.32776, 47.604236 ], [ -122.327702, 47.604628 ], [ -122.327184, 47.605077 ], [ -122.326558, 47.605139 ], [ -122.326533, 47.605129 ], [ -122.326226, 47.604395 ], [ -122.326372, 47.603792 ], [ -122.326569, 47.603794 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31063, 47.599798 ], [ -122.310629, 47.600222 ], [ -122.309625, 47.600223 ], [ -122.309626, 47.59987 ], [ -122.309705, 47.599827 ], [ -122.31063, 47.599798 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312895, 47.604339 ], [ -122.312866, 47.604342 ], [ -122.312519, 47.603934 ], [ -122.312621, 47.603928 ], [ -122.313187, 47.603934 ], [ -122.312895, 47.604339 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314274, 47.598742 ], [ -122.313907, 47.59925 ], [ -122.313658, 47.598993 ], [ -122.314046, 47.598691 ], [ -122.314274, 47.598742 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321303, 47.605645 ], [ -122.321167, 47.60558 ], [ -122.320921, 47.604903 ], [ -122.321266, 47.604585 ], [ -122.32136, 47.604576 ], [ -122.321665, 47.605315 ], [ -122.321303, 47.605645 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311769, 47.598597 ], [ -122.31141, 47.598588 ], [ -122.311582, 47.598331 ], [ -122.311617, 47.598333 ], [ -122.311769, 47.598597 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313984, 47.601279 ], [ -122.313981, 47.601994 ], [ -122.313734, 47.602143 ], [ -122.313737, 47.601192 ], [ -122.313984, 47.601279 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310559, 47.607112 ], [ -122.310555, 47.608625 ], [ -122.310304, 47.608763 ], [ -122.309938, 47.60856 ], [ -122.309941, 47.607105 ], [ -122.310559, 47.607112 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317489, 47.609692 ], [ -122.317255, 47.60985 ], [ -122.316972, 47.609978 ], [ -122.316163, 47.609975 ], [ -122.316149, 47.609953 ], [ -122.316397, 47.609391 ], [ -122.317798, 47.609396 ], [ -122.317489, 47.609692 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323926, 47.60659 ], [ -122.323476, 47.606559 ], [ -122.32346, 47.606354 ], [ -122.323788, 47.606061 ], [ -122.323828, 47.606066 ], [ -122.324152, 47.606388 ], [ -122.323926, 47.60659 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313071, 47.602455 ], [ -122.312904, 47.602681 ], [ -122.312874, 47.60268 ], [ -122.312716, 47.602456 ], [ -122.313071, 47.602455 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324727, 47.598159 ], [ -122.324725, 47.598777 ], [ -122.324722, 47.598779 ], [ -122.324096, 47.598775 ], [ -122.324075, 47.598756 ], [ -122.324077, 47.598143 ], [ -122.324727, 47.598159 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320921, 47.604903 ], [ -122.320429, 47.604902 ], [ -122.320359, 47.604821 ], [ -122.320771, 47.604408 ], [ -122.321021, 47.604405 ], [ -122.321266, 47.604585 ], [ -122.320921, 47.604903 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308947, 47.603521 ], [ -122.308974, 47.603522 ], [ -122.30913, 47.603769 ], [ -122.308776, 47.603767 ], [ -122.308947, 47.603521 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326028, 47.601975 ], [ -122.32603, 47.601294 ], [ -122.326691, 47.601304 ], [ -122.326708, 47.601318 ], [ -122.326707, 47.601873 ], [ -122.326028, 47.601975 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323852, 47.605455 ], [ -122.32388, 47.60543 ], [ -122.32416, 47.605322 ], [ -122.324316, 47.605308 ], [ -122.32446, 47.605655 ], [ -122.324124, 47.605965 ], [ -122.32403, 47.605882 ], [ -122.323852, 47.605455 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3097, 47.607193 ], [ -122.309155, 47.608007 ], [ -122.308267, 47.607277 ], [ -122.308222, 47.607221 ], [ -122.3097, 47.607193 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316506, 47.606085 ], [ -122.316504, 47.606379 ], [ -122.316306, 47.606694 ], [ -122.316149, 47.60683 ], [ -122.316153, 47.606009 ], [ -122.316506, 47.606085 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309948, 47.599556 ], [ -122.310152, 47.599417 ], [ -122.310747, 47.599437 ], [ -122.310785, 47.599531 ], [ -122.31063, 47.599798 ], [ -122.309705, 47.599827 ], [ -122.309948, 47.599556 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.045454545454545456 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319319, 47.607005 ], [ -122.319983, 47.607784 ], [ -122.320083, 47.608025 ], [ -122.320014, 47.608325 ], [ -122.31984, 47.608671 ], [ -122.31958, 47.609034 ], [ -122.319118, 47.609491 ], [ -122.319086, 47.609515 ], [ -122.319023, 47.609471 ], [ -122.318577, 47.607148 ], [ -122.318769, 47.606995 ], [ -122.319319, 47.607005 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31122, 47.600296 ], [ -122.312344, 47.600307 ], [ -122.312317, 47.600383 ], [ -122.311127, 47.600441 ], [ -122.31122, 47.600296 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320301, 47.605711 ], [ -122.320435, 47.606085 ], [ -122.320436, 47.606314 ], [ -122.320323, 47.606633 ], [ -122.320263, 47.606703 ], [ -122.319745, 47.606715 ], [ -122.319747, 47.605714 ], [ -122.320301, 47.605711 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319741, 47.603949 ], [ -122.320132, 47.603949 ], [ -122.320339, 47.603985 ], [ -122.320312, 47.604791 ], [ -122.319745, 47.604792 ], [ -122.31974, 47.604788 ], [ -122.319741, 47.603949 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308315, 47.602144 ], [ -122.308314, 47.601261 ], [ -122.30935, 47.601264 ], [ -122.309348, 47.602158 ], [ -122.309305, 47.602161 ], [ -122.308511, 47.60216 ], [ -122.30832, 47.60215 ], [ -122.308315, 47.602144 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318901, 47.601521 ], [ -122.318904, 47.601781 ], [ -122.318457, 47.601956 ], [ -122.318043, 47.601755 ], [ -122.318035, 47.601528 ], [ -122.318038, 47.601203 ], [ -122.318246, 47.600688 ], [ -122.318444, 47.600803 ], [ -122.318505, 47.600842 ], [ -122.318784, 47.601249 ], [ -122.318901, 47.601521 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317489, 47.609692 ], [ -122.317466, 47.610471 ], [ -122.317254, 47.610485 ], [ -122.317255, 47.60985 ], [ -122.317489, 47.609692 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316783, 47.59845 ], [ -122.316785, 47.597921 ], [ -122.317511, 47.597921 ], [ -122.317509, 47.598451 ], [ -122.316783, 47.59845 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.083333333333333329 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317787, 47.602355 ], [ -122.317785, 47.603111 ], [ -122.317784, 47.603112 ], [ -122.31712, 47.603103 ], [ -122.317122, 47.602388 ], [ -122.317289, 47.602202 ], [ -122.317595, 47.602188 ], [ -122.31778, 47.602349 ], [ -122.317787, 47.602355 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323047, 47.608104 ], [ -122.323713, 47.608609 ], [ -122.32315, 47.608848 ], [ -122.322949, 47.608376 ], [ -122.323047, 47.608104 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31711, 47.606035 ], [ -122.317109, 47.606377 ], [ -122.316504, 47.606379 ], [ -122.316506, 47.606085 ], [ -122.316541, 47.606037 ], [ -122.31711, 47.606035 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322663, 47.605992 ], [ -122.322657, 47.606026 ], [ -122.3223, 47.606352 ], [ -122.32184, 47.606404 ], [ -122.3218, 47.606158 ], [ -122.322216, 47.605777 ], [ -122.322663, 47.605992 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312235, 47.60127 ], [ -122.312235, 47.600644 ], [ -122.312317, 47.600383 ], [ -122.312344, 47.600307 ], [ -122.312439, 47.600117 ], [ -122.312925, 47.600215 ], [ -122.313058, 47.600318 ], [ -122.313055, 47.601272 ], [ -122.312235, 47.60127 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324062, 47.597763 ], [ -122.324741, 47.598139 ], [ -122.324727, 47.598159 ], [ -122.324077, 47.598143 ], [ -122.323952, 47.59794 ], [ -122.324062, 47.597763 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314828, 47.605724 ], [ -122.313431, 47.605694 ], [ -122.313242, 47.605291 ], [ -122.313352, 47.60517 ], [ -122.313561, 47.604955 ], [ -122.314832, 47.604965 ], [ -122.314829, 47.605721 ], [ -122.314828, 47.605724 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314806, 47.601605 ], [ -122.314403, 47.601602 ], [ -122.314303, 47.601274 ], [ -122.31491, 47.600775 ], [ -122.315145, 47.600772 ], [ -122.315243, 47.600837 ], [ -122.314806, 47.601605 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323777, 47.605482 ], [ -122.323356, 47.605382 ], [ -122.323117, 47.604808 ], [ -122.323315, 47.604594 ], [ -122.32361, 47.604776 ], [ -122.32388, 47.60543 ], [ -122.323852, 47.605455 ], [ -122.323777, 47.605482 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316542, 47.605389 ], [ -122.316054, 47.604775 ], [ -122.317109, 47.604778 ], [ -122.317113, 47.604781 ], [ -122.317111, 47.60539 ], [ -122.316542, 47.605389 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.083333333333333329 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318987, 47.602157 ], [ -122.318552, 47.602588 ], [ -122.318189, 47.602412 ], [ -122.318129, 47.602358 ], [ -122.318433, 47.601978 ], [ -122.318457, 47.601956 ], [ -122.318904, 47.601781 ], [ -122.319049, 47.602047 ], [ -122.318987, 47.602157 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325372, 47.598781 ], [ -122.325451, 47.598717 ], [ -122.326038, 47.599199 ], [ -122.326037, 47.599611 ], [ -122.326033, 47.599613 ], [ -122.325492, 47.59961 ], [ -122.32537, 47.599443 ], [ -122.325372, 47.598781 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326691, 47.601304 ], [ -122.326697, 47.60046 ], [ -122.327059, 47.600462 ], [ -122.327085, 47.600495 ], [ -122.32744, 47.601283 ], [ -122.326708, 47.601318 ], [ -122.326691, 47.601304 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310601, 47.601291 ], [ -122.310933, 47.60132 ], [ -122.310931, 47.601813 ], [ -122.310144, 47.601803 ], [ -122.310146, 47.601289 ], [ -122.310601, 47.601291 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316092, 47.597918 ], [ -122.31625, 47.597888 ], [ -122.316242, 47.599159 ], [ -122.316109, 47.599164 ], [ -122.316088, 47.599144 ], [ -122.316092, 47.597918 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310965, 47.598632 ], [ -122.31141, 47.598588 ], [ -122.311769, 47.598597 ], [ -122.312193, 47.59867 ], [ -122.312204, 47.598696 ], [ -122.311962, 47.598859 ], [ -122.311216, 47.598859 ], [ -122.310965, 47.598632 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312874, 47.60268 ], [ -122.312609, 47.603095 ], [ -122.312533, 47.603099 ], [ -122.312204, 47.603095 ], [ -122.312202, 47.602482 ], [ -122.312231, 47.602395 ], [ -122.312716, 47.602456 ], [ -122.312874, 47.60268 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310732, 47.60295 ], [ -122.310474, 47.603094 ], [ -122.309875, 47.603068 ], [ -122.309625, 47.603042 ], [ -122.309624, 47.602389 ], [ -122.310749, 47.602516 ], [ -122.310747, 47.602917 ], [ -122.310732, 47.60295 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317054, 47.600076 ], [ -122.317059, 47.599616 ], [ -122.317391, 47.599624 ], [ -122.317763, 47.599771 ], [ -122.318165, 47.600138 ], [ -122.318145, 47.600411 ], [ -122.317054, 47.600076 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311723, 47.599068 ], [ -122.311725, 47.599418 ], [ -122.311395, 47.599422 ], [ -122.311394, 47.599068 ], [ -122.311723, 47.599068 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323365, 47.602292 ], [ -122.322102, 47.602315 ], [ -122.321895, 47.602179 ], [ -122.322018, 47.601945 ], [ -122.323256, 47.601947 ], [ -122.323365, 47.602292 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314303, 47.601274 ], [ -122.313984, 47.601279 ], [ -122.313737, 47.601192 ], [ -122.313673, 47.601155 ], [ -122.313675, 47.600545 ], [ -122.31383, 47.600437 ], [ -122.314386, 47.60044 ], [ -122.31491, 47.600775 ], [ -122.314303, 47.601274 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317122, 47.602388 ], [ -122.31712, 47.603103 ], [ -122.317116, 47.603107 ], [ -122.316505, 47.603107 ], [ -122.31651, 47.602386 ], [ -122.317122, 47.602388 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.066666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31469, 47.602219 ], [ -122.314566, 47.602449 ], [ -122.313573, 47.602522 ], [ -122.31353, 47.602394 ], [ -122.313531, 47.60233 ], [ -122.313734, 47.602143 ], [ -122.313981, 47.601994 ], [ -122.314416, 47.601966 ], [ -122.314657, 47.60217 ], [ -122.31469, 47.602219 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316701, 47.599468 ], [ -122.317059, 47.599616 ], [ -122.317054, 47.600076 ], [ -122.316959, 47.600228 ], [ -122.31669, 47.600433 ], [ -122.316701, 47.599468 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321045, 47.596861 ], [ -122.321045, 47.596535 ], [ -122.321283, 47.596583 ], [ -122.322782, 47.597123 ], [ -122.322779, 47.597937 ], [ -122.321952, 47.597932 ], [ -122.321045, 47.596861 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320427, 47.605587 ], [ -122.320429, 47.604902 ], [ -122.320921, 47.604903 ], [ -122.321167, 47.60558 ], [ -122.320427, 47.605587 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31762, 47.600779 ], [ -122.316663, 47.600489 ], [ -122.31669, 47.600433 ], [ -122.316959, 47.600228 ], [ -122.318146, 47.600498 ], [ -122.318153, 47.600572 ], [ -122.31762, 47.600779 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316505, 47.603107 ], [ -122.316325, 47.603225 ], [ -122.315952, 47.603061 ], [ -122.315958, 47.602212 ], [ -122.316237, 47.602174 ], [ -122.316281, 47.60218 ], [ -122.31651, 47.602386 ], [ -122.316505, 47.603107 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310958, 47.603297 ], [ -122.310732, 47.60295 ], [ -122.310747, 47.602917 ], [ -122.31142, 47.602917 ], [ -122.311916, 47.603241 ], [ -122.311426, 47.603315 ], [ -122.311113, 47.603317 ], [ -122.310958, 47.603297 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308318, 47.603089 ], [ -122.308329, 47.603105 ], [ -122.308324, 47.603813 ], [ -122.308278, 47.603932 ], [ -122.307985, 47.603925 ], [ -122.307941, 47.603921 ], [ -122.307693, 47.603509 ], [ -122.307984, 47.603093 ], [ -122.308318, 47.603089 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321092, 47.606357 ], [ -122.320436, 47.606314 ], [ -122.320435, 47.606085 ], [ -122.321118, 47.606079 ], [ -122.321106, 47.606346 ], [ -122.321092, 47.606357 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321222, 47.609483 ], [ -122.321019, 47.609994 ], [ -122.319273, 47.610351 ], [ -122.319259, 47.610352 ], [ -122.319086, 47.609515 ], [ -122.319118, 47.609491 ], [ -122.321222, 47.609483 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309415, 47.599367 ], [ -122.308169, 47.59937 ], [ -122.308268, 47.599245 ], [ -122.308434, 47.599109 ], [ -122.309413, 47.599117 ], [ -122.309415, 47.599367 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.307984, 47.603093 ], [ -122.307693, 47.603509 ], [ -122.307656, 47.603509 ], [ -122.307338, 47.603093 ], [ -122.307376, 47.60309 ], [ -122.307955, 47.603091 ], [ -122.307984, 47.603093 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316569, 47.608157 ], [ -122.317423, 47.608154 ], [ -122.317453, 47.60835 ], [ -122.316655, 47.608353 ], [ -122.316569, 47.608157 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308314, 47.604061 ], [ -122.308309, 47.605237 ], [ -122.308309, 47.605266 ], [ -122.308298, 47.605273 ], [ -122.308201, 47.605269 ], [ -122.307684, 47.60432 ], [ -122.307985, 47.603925 ], [ -122.308278, 47.603932 ], [ -122.308314, 47.604061 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.083333333333333329 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316397, 47.609391 ], [ -122.316149, 47.609953 ], [ -122.315863, 47.609839 ], [ -122.31574, 47.609778 ], [ -122.315738, 47.608946 ], [ -122.316021, 47.608664 ], [ -122.316307, 47.608831 ], [ -122.3164, 47.60898 ], [ -122.316397, 47.609391 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.13333333333333333 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325423, 47.60274 ], [ -122.325104, 47.602526 ], [ -122.324867, 47.602201 ], [ -122.32487, 47.601069 ], [ -122.325363, 47.60087 ], [ -122.325497, 47.60087 ], [ -122.32603, 47.601294 ], [ -122.326028, 47.601975 ], [ -122.325543, 47.602786 ], [ -122.325423, 47.60274 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312203, 47.607393 ], [ -122.312535, 47.607714 ], [ -122.312532, 47.60859 ], [ -122.312462, 47.608631 ], [ -122.312167, 47.608628 ], [ -122.31217, 47.607426 ], [ -122.312203, 47.607393 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321226, 47.607506 ], [ -122.320676, 47.607517 ], [ -122.320481, 47.60702 ], [ -122.321072, 47.607025 ], [ -122.321216, 47.607364 ], [ -122.321226, 47.607506 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321724, 47.608663 ], [ -122.31984, 47.608671 ], [ -122.320014, 47.608325 ], [ -122.321588, 47.608315 ], [ -122.321629, 47.608377 ], [ -122.321724, 47.608663 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.41666666666666669 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322554, 47.607303 ], [ -122.322625, 47.607471 ], [ -122.321629, 47.608377 ], [ -122.321588, 47.608315 ], [ -122.321449, 47.607923 ], [ -122.321437, 47.607796 ], [ -122.322172, 47.607145 ], [ -122.322429, 47.607184 ], [ -122.322554, 47.607303 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324858, 47.60473 ], [ -122.325431, 47.604774 ], [ -122.325775, 47.605582 ], [ -122.325559, 47.60578 ], [ -122.325212, 47.605792 ], [ -122.324813, 47.604856 ], [ -122.324858, 47.60473 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317783, 47.603943 ], [ -122.317779, 47.604781 ], [ -122.317113, 47.604781 ], [ -122.317109, 47.604778 ], [ -122.317117, 47.603939 ], [ -122.317782, 47.603942 ], [ -122.317783, 47.603943 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311278, 47.599808 ], [ -122.312303, 47.599833 ], [ -122.312369, 47.599857 ], [ -122.31243, 47.600093 ], [ -122.311275, 47.600115 ], [ -122.311278, 47.599808 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313575, 47.603262 ], [ -122.31351, 47.603099 ], [ -122.313574, 47.602848 ], [ -122.314568, 47.602843 ], [ -122.314706, 47.60315 ], [ -122.31464, 47.603263 ], [ -122.313575, 47.603262 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.53333333333333333 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315585, 47.599508 ], [ -122.316096, 47.599182 ], [ -122.316027, 47.599545 ], [ -122.315792, 47.599977 ], [ -122.315388, 47.599936 ], [ -122.315585, 47.599508 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313568, 47.59756 ], [ -122.312929, 47.598121 ], [ -122.312707, 47.597975 ], [ -122.312695, 47.597843 ], [ -122.313432, 47.597207 ], [ -122.31346, 47.597205 ], [ -122.313568, 47.59756 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320794, 47.600009 ], [ -122.320331, 47.599883 ], [ -122.320332, 47.598766 ], [ -122.320543, 47.598417 ], [ -122.321503, 47.598907 ], [ -122.321497, 47.599861 ], [ -122.321167, 47.599969 ], [ -122.320794, 47.600009 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325673, 47.602907 ], [ -122.325543, 47.602786 ], [ -122.326028, 47.601975 ], [ -122.326707, 47.601873 ], [ -122.32685, 47.602095 ], [ -122.325673, 47.602907 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318188, 47.605707 ], [ -122.318771, 47.605793 ], [ -122.318769, 47.606995 ], [ -122.318577, 47.607148 ], [ -122.31778, 47.607124 ], [ -122.317782, 47.60571 ], [ -122.318188, 47.605707 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310752, 47.604094 ], [ -122.31047, 47.603932 ], [ -122.310472, 47.60312 ], [ -122.310474, 47.603094 ], [ -122.310732, 47.60295 ], [ -122.310958, 47.603297 ], [ -122.310958, 47.603948 ], [ -122.310752, 47.604094 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318552, 47.602588 ], [ -122.318563, 47.603114 ], [ -122.318188, 47.603108 ], [ -122.318189, 47.602412 ], [ -122.318552, 47.602588 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1388888888888889 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32331, 47.599563 ], [ -122.323195, 47.599656 ], [ -122.323191, 47.599658 ], [ -122.3232, 47.598762 ], [ -122.323426, 47.598692 ], [ -122.323548, 47.598753 ], [ -122.323544, 47.599197 ], [ -122.32349, 47.599385 ], [ -122.32331, 47.599563 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311127, 47.600441 ], [ -122.312317, 47.600383 ], [ -122.312235, 47.600644 ], [ -122.310983, 47.600647 ], [ -122.311127, 47.600441 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311437, 47.609348 ], [ -122.311224, 47.609272 ], [ -122.311189, 47.609252 ], [ -122.311192, 47.608752 ], [ -122.311535, 47.609208 ], [ -122.311437, 47.609348 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318784, 47.601249 ], [ -122.318505, 47.600842 ], [ -122.319967, 47.600328 ], [ -122.319994, 47.600841 ], [ -122.318784, 47.601249 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313773, 47.598491 ], [ -122.313745, 47.597855 ], [ -122.314378, 47.597964 ], [ -122.314443, 47.598008 ], [ -122.314441, 47.59872 ], [ -122.314274, 47.598742 ], [ -122.314046, 47.598691 ], [ -122.313773, 47.598491 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311535, 47.609208 ], [ -122.311563, 47.609209 ], [ -122.311695, 47.609441 ], [ -122.311437, 47.609348 ], [ -122.311535, 47.609208 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326226, 47.604395 ], [ -122.326533, 47.605129 ], [ -122.326098, 47.605523 ], [ -122.325775, 47.605582 ], [ -122.325431, 47.604774 ], [ -122.326226, 47.604395 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.53333333333333333 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319318, 47.602166 ], [ -122.319748, 47.602231 ], [ -122.319745, 47.603114 ], [ -122.319705, 47.603144 ], [ -122.319252, 47.603109 ], [ -122.319318, 47.602166 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321266, 47.603649 ], [ -122.321506, 47.604203 ], [ -122.321527, 47.604415 ], [ -122.32136, 47.604576 ], [ -122.321266, 47.604585 ], [ -122.321021, 47.604405 ], [ -122.32088, 47.603878 ], [ -122.321266, 47.603649 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317763, 47.599771 ], [ -122.317757, 47.5988 ], [ -122.317967, 47.598753 ], [ -122.318394, 47.598841 ], [ -122.318438, 47.598875 ], [ -122.318447, 47.599806 ], [ -122.318165, 47.600138 ], [ -122.317763, 47.599771 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315863, 47.609839 ], [ -122.315488, 47.610378 ], [ -122.315089, 47.610351 ], [ -122.314426, 47.610216 ], [ -122.314813, 47.609767 ], [ -122.31574, 47.609778 ], [ -122.315863, 47.609839 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32346, 47.606354 ], [ -122.323333, 47.606052 ], [ -122.32366, 47.605752 ], [ -122.323788, 47.606061 ], [ -122.32346, 47.606354 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317236, 47.605792 ], [ -122.31711, 47.606035 ], [ -122.316541, 47.606037 ], [ -122.316542, 47.605793 ], [ -122.317236, 47.605792 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318992, 47.603175 ], [ -122.318987, 47.602157 ], [ -122.319049, 47.602047 ], [ -122.319318, 47.602166 ], [ -122.319252, 47.603109 ], [ -122.318992, 47.603175 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316542, 47.605793 ], [ -122.316541, 47.606037 ], [ -122.316506, 47.606085 ], [ -122.316153, 47.606009 ], [ -122.315891, 47.605828 ], [ -122.315891, 47.605717 ], [ -122.316519, 47.60572 ], [ -122.316542, 47.605793 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.083333333333333329 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310747, 47.599437 ], [ -122.310741, 47.598549 ], [ -122.310965, 47.598632 ], [ -122.311216, 47.598859 ], [ -122.311394, 47.599068 ], [ -122.311395, 47.599422 ], [ -122.311172, 47.599646 ], [ -122.310785, 47.599531 ], [ -122.310747, 47.599437 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314638, 47.603942 ], [ -122.31464, 47.603263 ], [ -122.314706, 47.60315 ], [ -122.315299, 47.60305 ], [ -122.315472, 47.603174 ], [ -122.31547, 47.604507 ], [ -122.315222, 47.604556 ], [ -122.314638, 47.603942 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320543, 47.598224 ], [ -122.319307, 47.59822 ], [ -122.319138, 47.597794 ], [ -122.320603, 47.597809 ], [ -122.320543, 47.598224 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318189, 47.602412 ], [ -122.318188, 47.603108 ], [ -122.318182, 47.603109 ], [ -122.317785, 47.603111 ], [ -122.317787, 47.602355 ], [ -122.318129, 47.602358 ], [ -122.318189, 47.602412 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323261, 47.600975 ], [ -122.323256, 47.601947 ], [ -122.322018, 47.601945 ], [ -122.322015, 47.601366 ], [ -122.322796, 47.60063 ], [ -122.323261, 47.600975 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313424, 47.598383 ], [ -122.313035, 47.598665 ], [ -122.313036, 47.598311 ], [ -122.31346, 47.598106 ], [ -122.313424, 47.598383 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318505, 47.600842 ], [ -122.318444, 47.600803 ], [ -122.319614, 47.599806 ], [ -122.320097, 47.600019 ], [ -122.319967, 47.600328 ], [ -122.318505, 47.600842 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311725, 47.599418 ], [ -122.312303, 47.599833 ], [ -122.311278, 47.599808 ], [ -122.311172, 47.599646 ], [ -122.311395, 47.599422 ], [ -122.311725, 47.599418 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309614, 47.605154 ], [ -122.309493, 47.605194 ], [ -122.308965, 47.60433 ], [ -122.3091, 47.60414 ], [ -122.309615, 47.604075 ], [ -122.309614, 47.605154 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312532, 47.60859 ], [ -122.312535, 47.607714 ], [ -122.313515, 47.607709 ], [ -122.313513, 47.60846 ], [ -122.313183, 47.608593 ], [ -122.312532, 47.60859 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314499, 47.599216 ], [ -122.314496, 47.598765 ], [ -122.314959, 47.598767 ], [ -122.315055, 47.599349 ], [ -122.315054, 47.599357 ], [ -122.314862, 47.599383 ], [ -122.314499, 47.599216 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313226, 47.603932 ], [ -122.313187, 47.603934 ], [ -122.312621, 47.603928 ], [ -122.312867, 47.603519 ], [ -122.312899, 47.603517 ], [ -122.313226, 47.603932 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316166, 47.608375 ], [ -122.316169, 47.607426 ], [ -122.316516, 47.607823 ], [ -122.316515, 47.60811 ], [ -122.316166, 47.608375 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.53333333333333333 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325363, 47.60087 ], [ -122.32487, 47.601069 ], [ -122.324713, 47.600975 ], [ -122.324716, 47.599931 ], [ -122.325366, 47.599935 ], [ -122.325363, 47.60087 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311447, 47.597726 ], [ -122.311199, 47.597762 ], [ -122.311199, 47.597266 ], [ -122.311226, 47.597251 ], [ -122.311344, 47.597209 ], [ -122.311587, 47.597493 ], [ -122.311447, 47.597726 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.307825, 47.599804 ], [ -122.308019, 47.599559 ], [ -122.309464, 47.599542 ], [ -122.309572, 47.599808 ], [ -122.307825, 47.599804 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312204, 47.603095 ], [ -122.312076, 47.603287 ], [ -122.311916, 47.603241 ], [ -122.31142, 47.602917 ], [ -122.311419, 47.602466 ], [ -122.312202, 47.602482 ], [ -122.312204, 47.603095 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319138, 47.597794 ], [ -122.318814, 47.597543 ], [ -122.318438, 47.597097 ], [ -122.318592, 47.596653 ], [ -122.318789, 47.59614 ], [ -122.319272, 47.596172 ], [ -122.321045, 47.596535 ], [ -122.321045, 47.596861 ], [ -122.320603, 47.597809 ], [ -122.319138, 47.597794 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.22222222222222221 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319967, 47.600328 ], [ -122.320097, 47.600019 ], [ -122.320331, 47.599883 ], [ -122.320794, 47.600009 ], [ -122.320891, 47.600802 ], [ -122.320885, 47.60122 ], [ -122.320173, 47.601367 ], [ -122.320138, 47.601326 ], [ -122.319994, 47.600841 ], [ -122.319967, 47.600328 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319381, 47.603955 ], [ -122.319718, 47.603931 ], [ -122.319741, 47.603949 ], [ -122.31974, 47.604788 ], [ -122.319378, 47.60479 ], [ -122.319381, 47.603955 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315304, 47.600865 ], [ -122.315887, 47.600862 ], [ -122.315886, 47.602182 ], [ -122.315357, 47.60218 ], [ -122.315306, 47.60173 ], [ -122.315304, 47.600865 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321118, 47.606079 ], [ -122.320435, 47.606085 ], [ -122.320301, 47.605711 ], [ -122.320427, 47.605587 ], [ -122.321167, 47.60558 ], [ -122.321303, 47.605645 ], [ -122.321306, 47.605663 ], [ -122.321118, 47.606079 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309872, 47.602093 ], [ -122.309609, 47.602347 ], [ -122.309348, 47.602158 ], [ -122.30935, 47.601264 ], [ -122.309588, 47.601042 ], [ -122.309875, 47.601206 ], [ -122.309872, 47.602093 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31984, 47.608671 ], [ -122.321724, 47.608663 ], [ -122.321823, 47.608851 ], [ -122.32186, 47.609008 ], [ -122.321832, 47.609022 ], [ -122.31958, 47.609034 ], [ -122.31984, 47.608671 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314826, 47.606042 ], [ -122.313511, 47.606011 ], [ -122.313431, 47.605694 ], [ -122.314828, 47.605724 ], [ -122.314827, 47.606037 ], [ -122.314826, 47.606042 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315902, 47.598996 ], [ -122.315909, 47.59792 ], [ -122.316092, 47.597918 ], [ -122.316088, 47.599144 ], [ -122.315902, 47.598996 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312841, 47.609214 ], [ -122.312869, 47.609214 ], [ -122.313119, 47.609597 ], [ -122.313145, 47.609953 ], [ -122.313078, 47.60994 ], [ -122.3125, 47.609731 ], [ -122.3125, 47.609718 ], [ -122.312841, 47.609214 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316569, 47.608157 ], [ -122.316655, 47.608353 ], [ -122.3166, 47.608592 ], [ -122.316307, 47.608831 ], [ -122.316021, 47.608664 ], [ -122.315999, 47.608585 ], [ -122.316166, 47.608375 ], [ -122.316515, 47.60811 ], [ -122.316569, 47.608157 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316971, 47.610476 ], [ -122.316164, 47.610423 ], [ -122.316163, 47.609975 ], [ -122.316972, 47.609978 ], [ -122.316971, 47.610476 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321497, 47.599861 ], [ -122.322196, 47.600077 ], [ -122.322282, 47.600131 ], [ -122.321632, 47.600759 ], [ -122.321367, 47.600759 ], [ -122.321167, 47.599969 ], [ -122.321497, 47.599861 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316882, 47.601604 ], [ -122.317095, 47.601863 ], [ -122.317094, 47.601882 ], [ -122.316581, 47.60188 ], [ -122.316581, 47.601584 ], [ -122.316882, 47.601604 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317595, 47.602188 ], [ -122.317617, 47.602138 ], [ -122.317954, 47.601862 ], [ -122.318122, 47.601977 ], [ -122.31778, 47.602349 ], [ -122.317595, 47.602188 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318187, 47.603943 ], [ -122.318182, 47.603109 ], [ -122.318188, 47.603108 ], [ -122.318563, 47.603114 ], [ -122.31881, 47.603286 ], [ -122.3188, 47.603941 ], [ -122.318191, 47.603943 ], [ -122.318187, 47.603943 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.27777777777777779 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320173, 47.601367 ], [ -122.320168, 47.602029 ], [ -122.319748, 47.602231 ], [ -122.319318, 47.602166 ], [ -122.319049, 47.602047 ], [ -122.318904, 47.601781 ], [ -122.318901, 47.601521 ], [ -122.320138, 47.601326 ], [ -122.320173, 47.601367 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313487, 47.597167 ], [ -122.313486, 47.5965 ], [ -122.314935, 47.596204 ], [ -122.314936, 47.596672 ], [ -122.314377, 47.59703 ], [ -122.313487, 47.597167 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317254, 47.610485 ], [ -122.317181, 47.61049 ], [ -122.316971, 47.610476 ], [ -122.316972, 47.609978 ], [ -122.317255, 47.60985 ], [ -122.317254, 47.610485 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.3232, 47.598762 ], [ -122.322866, 47.598729 ], [ -122.322779, 47.598608 ], [ -122.322781, 47.597939 ], [ -122.323426, 47.597936 ], [ -122.323428, 47.597937 ], [ -122.323426, 47.598692 ], [ -122.3232, 47.598762 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316948, 47.601345 ], [ -122.317181, 47.601269 ], [ -122.317194, 47.601611 ], [ -122.317095, 47.601863 ], [ -122.316882, 47.601604 ], [ -122.316885, 47.601488 ], [ -122.316948, 47.601345 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320138, 47.601326 ], [ -122.318901, 47.601521 ], [ -122.318784, 47.601249 ], [ -122.319994, 47.600841 ], [ -122.320138, 47.601326 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309907, 47.602076 ], [ -122.310144, 47.601803 ], [ -122.310931, 47.601813 ], [ -122.310945, 47.601896 ], [ -122.310921, 47.602091 ], [ -122.309907, 47.602076 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1388888888888889 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321503, 47.598907 ], [ -122.320543, 47.598417 ], [ -122.320543, 47.598224 ], [ -122.320603, 47.597809 ], [ -122.321045, 47.596861 ], [ -122.321952, 47.597932 ], [ -122.32195, 47.598598 ], [ -122.321924, 47.59865 ], [ -122.321503, 47.598907 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322781, 47.597939 ], [ -122.322779, 47.597937 ], [ -122.322782, 47.597123 ], [ -122.323137, 47.597251 ], [ -122.323428, 47.597412 ], [ -122.323426, 47.597936 ], [ -122.322781, 47.597939 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323428, 47.597937 ], [ -122.323952, 47.59794 ], [ -122.324077, 47.598143 ], [ -122.324075, 47.598756 ], [ -122.323548, 47.598753 ], [ -122.323426, 47.598692 ], [ -122.323428, 47.597937 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31353, 47.602394 ], [ -122.313573, 47.602522 ], [ -122.313574, 47.602848 ], [ -122.31351, 47.603099 ], [ -122.313154, 47.603098 ], [ -122.312904, 47.602681 ], [ -122.313071, 47.602455 ], [ -122.31353, 47.602394 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32597, 47.606505 ], [ -122.326224, 47.607115 ], [ -122.326096, 47.607277 ], [ -122.325914, 47.607427 ], [ -122.325624, 47.60673 ], [ -122.325868, 47.606509 ], [ -122.32597, 47.606505 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.19444444444444445 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32184, 47.606404 ], [ -122.3223, 47.606352 ], [ -122.322519, 47.606886 ], [ -122.322429, 47.607184 ], [ -122.322172, 47.607145 ], [ -122.321832, 47.606782 ], [ -122.321812, 47.606736 ], [ -122.321826, 47.606435 ], [ -122.32184, 47.606404 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312232, 47.601276 ], [ -122.310968, 47.601269 ], [ -122.310971, 47.600656 ], [ -122.310983, 47.600647 ], [ -122.312235, 47.600644 ], [ -122.312235, 47.60127 ], [ -122.312232, 47.601276 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32451, 47.607201 ], [ -122.324736, 47.606998 ], [ -122.325069, 47.606965 ], [ -122.325428, 47.607826 ], [ -122.325024, 47.608158 ], [ -122.324886, 47.608104 ], [ -122.32451, 47.607201 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321812, 47.606736 ], [ -122.321832, 47.606782 ], [ -122.321216, 47.607364 ], [ -122.321072, 47.607025 ], [ -122.321072, 47.607024 ], [ -122.32135, 47.60677 ], [ -122.321812, 47.606736 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.090909090909090912 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31511, 47.59943 ], [ -122.315054, 47.599357 ], [ -122.315055, 47.599349 ], [ -122.315671, 47.598869 ], [ -122.315902, 47.598996 ], [ -122.316088, 47.599144 ], [ -122.316109, 47.599164 ], [ -122.316096, 47.599182 ], [ -122.315585, 47.599508 ], [ -122.315287, 47.599471 ], [ -122.31511, 47.59943 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312231, 47.601886 ], [ -122.312232, 47.601276 ], [ -122.312235, 47.60127 ], [ -122.313055, 47.601272 ], [ -122.313265, 47.601357 ], [ -122.313263, 47.601977 ], [ -122.312261, 47.601981 ], [ -122.312231, 47.601886 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309355, 47.606602 ], [ -122.308315, 47.606596 ], [ -122.308279, 47.606373 ], [ -122.308291, 47.606288 ], [ -122.309278, 47.606314 ], [ -122.309355, 47.606602 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323426, 47.597936 ], [ -122.323428, 47.597412 ], [ -122.324062, 47.597763 ], [ -122.323952, 47.59794 ], [ -122.323428, 47.597937 ], [ -122.323426, 47.597936 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309929, 47.605262 ], [ -122.310747, 47.605248 ], [ -122.310917, 47.605341 ], [ -122.31091, 47.606774 ], [ -122.310614, 47.607094 ], [ -122.310559, 47.607112 ], [ -122.309941, 47.607105 ], [ -122.309931, 47.607101 ], [ -122.309929, 47.605262 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7142857142857143 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319423, 47.598772 ], [ -122.319306, 47.598714 ], [ -122.319307, 47.59822 ], [ -122.320543, 47.598224 ], [ -122.320543, 47.598417 ], [ -122.320332, 47.598766 ], [ -122.319423, 47.598772 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309226, 47.603103 ], [ -122.309267, 47.603106 ], [ -122.308974, 47.603522 ], [ -122.308947, 47.603521 ], [ -122.308656, 47.603103 ], [ -122.30866, 47.603103 ], [ -122.309226, 47.603103 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7142857142857143 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324316, 47.605308 ], [ -122.324813, 47.604856 ], [ -122.325212, 47.605792 ], [ -122.32497, 47.606016 ], [ -122.32476, 47.606039 ], [ -122.32446, 47.605655 ], [ -122.324316, 47.605308 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324716, 47.599931 ], [ -122.324666, 47.599763 ], [ -122.325413, 47.599768 ], [ -122.325366, 47.599935 ], [ -122.324716, 47.599931 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322444, 47.603916 ], [ -122.322394, 47.604057 ], [ -122.321965, 47.604448 ], [ -122.321527, 47.604415 ], [ -122.321506, 47.604203 ], [ -122.322225, 47.603593 ], [ -122.322444, 47.603916 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.26666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31881, 47.603286 ], [ -122.318563, 47.603114 ], [ -122.318552, 47.602588 ], [ -122.318987, 47.602157 ], [ -122.318992, 47.603175 ], [ -122.31881, 47.603286 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319373, 47.604791 ], [ -122.318797, 47.604777 ], [ -122.318803, 47.603944 ], [ -122.319381, 47.603955 ], [ -122.319378, 47.60479 ], [ -122.319373, 47.604791 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.045454545454545456 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317423, 47.608154 ], [ -122.317423, 47.607817 ], [ -122.317591, 47.60736 ], [ -122.317752, 47.607133 ], [ -122.31778, 47.607124 ], [ -122.318577, 47.607148 ], [ -122.319023, 47.609471 ], [ -122.317994, 47.609263 ], [ -122.317732, 47.608976 ], [ -122.317527, 47.60859 ], [ -122.317453, 47.60835 ], [ -122.317423, 47.608154 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.42857142857142855 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318038, 47.601203 ], [ -122.317628, 47.601638 ], [ -122.317544, 47.601594 ], [ -122.317301, 47.601111 ], [ -122.31762, 47.600779 ], [ -122.318153, 47.600572 ], [ -122.318246, 47.600688 ], [ -122.318038, 47.601203 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7142857142857143 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323104, 47.606971 ], [ -122.323296, 47.607443 ], [ -122.323081, 47.607732 ], [ -122.322937, 47.607785 ], [ -122.322625, 47.607471 ], [ -122.322554, 47.607303 ], [ -122.323104, 47.606971 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.325069, 47.606965 ], [ -122.325284, 47.606767 ], [ -122.325624, 47.60673 ], [ -122.325914, 47.607427 ], [ -122.325428, 47.607826 ], [ -122.325069, 47.606965 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318992, 47.598775 ], [ -122.319146, 47.598757 ], [ -122.319146, 47.59968 ], [ -122.318992, 47.599686 ], [ -122.318992, 47.598775 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320422, 47.606981 ], [ -122.320481, 47.60702 ], [ -122.320676, 47.607517 ], [ -122.320135, 47.607998 ], [ -122.320083, 47.608025 ], [ -122.319983, 47.607784 ], [ -122.320422, 47.606981 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310152, 47.599417 ], [ -122.310154, 47.598229 ], [ -122.310623, 47.598385 ], [ -122.310741, 47.598549 ], [ -122.310747, 47.599437 ], [ -122.310152, 47.599417 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315753, 47.604562 ], [ -122.316325, 47.603936 ], [ -122.317116, 47.603938 ], [ -122.317117, 47.603939 ], [ -122.317109, 47.604778 ], [ -122.316054, 47.604775 ], [ -122.315894, 47.604713 ], [ -122.315753, 47.604562 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312298, 47.605274 ], [ -122.312211, 47.605275 ], [ -122.312193, 47.605263 ], [ -122.312199, 47.603935 ], [ -122.312519, 47.603934 ], [ -122.312866, 47.604342 ], [ -122.312298, 47.605274 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31047, 47.603932 ], [ -122.309855, 47.603964 ], [ -122.310178, 47.60352 ], [ -122.310207, 47.603521 ], [ -122.31047, 47.603932 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318438, 47.598875 ], [ -122.31881, 47.598757 ], [ -122.318992, 47.598775 ], [ -122.318992, 47.599686 ], [ -122.318447, 47.599806 ], [ -122.318438, 47.598875 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322196, 47.600077 ], [ -122.322207, 47.599105 ], [ -122.322731, 47.599105 ], [ -122.322832, 47.600011 ], [ -122.322653, 47.600293 ], [ -122.322282, 47.600131 ], [ -122.322196, 47.600077 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314827, 47.606037 ], [ -122.314828, 47.605724 ], [ -122.314829, 47.605721 ], [ -122.315889, 47.605712 ], [ -122.315891, 47.605717 ], [ -122.315891, 47.605828 ], [ -122.315775, 47.606028 ], [ -122.314827, 47.606037 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1111111111111111 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313035, 47.598665 ], [ -122.312981, 47.598954 ], [ -122.312605, 47.599077 ], [ -122.312204, 47.598696 ], [ -122.312193, 47.59867 ], [ -122.312192, 47.598411 ], [ -122.312707, 47.597975 ], [ -122.312929, 47.598121 ], [ -122.313036, 47.598311 ], [ -122.313035, 47.598665 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308656, 47.603103 ], [ -122.308329, 47.603105 ], [ -122.308318, 47.603089 ], [ -122.30832, 47.60215 ], [ -122.308511, 47.60216 ], [ -122.308946, 47.602681 ], [ -122.30866, 47.603103 ], [ -122.308656, 47.603103 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321437, 47.607796 ], [ -122.321226, 47.607506 ], [ -122.321216, 47.607364 ], [ -122.321832, 47.606782 ], [ -122.322172, 47.607145 ], [ -122.321437, 47.607796 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313183, 47.608593 ], [ -122.313513, 47.60846 ], [ -122.313746, 47.608628 ], [ -122.313744, 47.610076 ], [ -122.313145, 47.609953 ], [ -122.313119, 47.609597 ], [ -122.313118, 47.608998 ], [ -122.313183, 47.608593 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32349, 47.599385 ], [ -122.323544, 47.599197 ], [ -122.324069, 47.5992 ], [ -122.324086, 47.599389 ], [ -122.32349, 47.599385 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.46666666666666667 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315287, 47.599471 ], [ -122.315585, 47.599508 ], [ -122.315388, 47.599936 ], [ -122.315157, 47.600206 ], [ -122.31507, 47.600061 ], [ -122.315287, 47.599471 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7142857142857143 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322904, 47.605795 ], [ -122.322886, 47.605796 ], [ -122.322573, 47.605046 ], [ -122.322743, 47.604889 ], [ -122.323117, 47.604808 ], [ -122.323356, 47.605382 ], [ -122.322904, 47.605795 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315671, 47.598869 ], [ -122.31543, 47.598692 ], [ -122.315434, 47.597799 ], [ -122.315909, 47.59792 ], [ -122.315902, 47.598996 ], [ -122.315671, 47.598869 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315145, 47.600772 ], [ -122.315157, 47.600206 ], [ -122.315388, 47.599936 ], [ -122.315792, 47.599977 ], [ -122.315897, 47.600859 ], [ -122.315887, 47.600862 ], [ -122.315304, 47.600865 ], [ -122.315243, 47.600837 ], [ -122.315145, 47.600772 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.307941, 47.603921 ], [ -122.307388, 47.603918 ], [ -122.307656, 47.603509 ], [ -122.307693, 47.603509 ], [ -122.307941, 47.603921 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317954, 47.601862 ], [ -122.318043, 47.601755 ], [ -122.318457, 47.601956 ], [ -122.318433, 47.601978 ], [ -122.318122, 47.601977 ], [ -122.317954, 47.601862 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31625, 47.600721 ], [ -122.316472, 47.599261 ], [ -122.316701, 47.599468 ], [ -122.31669, 47.600433 ], [ -122.316663, 47.600489 ], [ -122.31625, 47.600721 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.083333333333333329 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.319745, 47.604792 ], [ -122.320312, 47.604791 ], [ -122.320359, 47.604821 ], [ -122.320429, 47.604902 ], [ -122.320427, 47.605587 ], [ -122.320301, 47.605711 ], [ -122.319747, 47.605714 ], [ -122.319743, 47.605712 ], [ -122.319745, 47.604792 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314813, 47.609767 ], [ -122.314815, 47.608947 ], [ -122.315738, 47.608946 ], [ -122.31574, 47.609778 ], [ -122.314813, 47.609767 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313658, 47.598993 ], [ -122.313133, 47.598964 ], [ -122.313709, 47.598518 ], [ -122.313773, 47.598491 ], [ -122.314046, 47.598691 ], [ -122.313658, 47.598993 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322625, 47.607471 ], [ -122.322937, 47.607785 ], [ -122.322935, 47.607825 ], [ -122.321823, 47.608851 ], [ -122.321724, 47.608663 ], [ -122.321629, 47.608377 ], [ -122.322625, 47.607471 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.21428571428571427 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312462, 47.608631 ], [ -122.312532, 47.60859 ], [ -122.313183, 47.608593 ], [ -122.313118, 47.608998 ], [ -122.312909, 47.609154 ], [ -122.312803, 47.609162 ], [ -122.312502, 47.608975 ], [ -122.312462, 47.608631 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317784, 47.603112 ], [ -122.317785, 47.603111 ], [ -122.318182, 47.603109 ], [ -122.318187, 47.603943 ], [ -122.317783, 47.603943 ], [ -122.317782, 47.603942 ], [ -122.317784, 47.603112 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311344, 47.597209 ], [ -122.312031, 47.596961 ], [ -122.311625, 47.597493 ], [ -122.311587, 47.597493 ], [ -122.311344, 47.597209 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311772, 47.598102 ], [ -122.311981, 47.598069 ], [ -122.312192, 47.598411 ], [ -122.312193, 47.59867 ], [ -122.311769, 47.598597 ], [ -122.311617, 47.598333 ], [ -122.311772, 47.598102 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318122, 47.601977 ], [ -122.318433, 47.601978 ], [ -122.318129, 47.602358 ], [ -122.317787, 47.602355 ], [ -122.31778, 47.602349 ], [ -122.318122, 47.601977 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312803, 47.609162 ], [ -122.312841, 47.609214 ], [ -122.3125, 47.609718 ], [ -122.312502, 47.608975 ], [ -122.312803, 47.609162 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.22222222222222221 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316239, 47.601053 ], [ -122.316101, 47.600839 ], [ -122.31616, 47.600791 ], [ -122.316179, 47.600781 ], [ -122.317256, 47.601142 ], [ -122.317181, 47.601269 ], [ -122.316948, 47.601345 ], [ -122.316389, 47.601202 ], [ -122.316239, 47.601053 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316785, 47.597921 ], [ -122.316621, 47.597745 ], [ -122.316621, 47.597081 ], [ -122.318432, 47.597102 ], [ -122.318401, 47.597155 ], [ -122.317972, 47.597621 ], [ -122.317511, 47.597921 ], [ -122.316785, 47.597921 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313732, 47.597844 ], [ -122.313745, 47.597855 ], [ -122.313773, 47.598491 ], [ -122.313709, 47.598518 ], [ -122.313424, 47.598383 ], [ -122.31346, 47.598106 ], [ -122.313732, 47.597844 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313561, 47.604955 ], [ -122.313568, 47.603935 ], [ -122.313571, 47.603931 ], [ -122.314638, 47.603942 ], [ -122.315222, 47.604556 ], [ -122.314832, 47.604965 ], [ -122.313561, 47.604955 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312202, 47.602482 ], [ -122.311419, 47.602466 ], [ -122.310989, 47.602162 ], [ -122.312234, 47.602182 ], [ -122.312231, 47.602395 ], [ -122.312202, 47.602482 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1388888888888889 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316242, 47.599159 ], [ -122.31625, 47.597888 ], [ -122.316621, 47.597745 ], [ -122.316785, 47.597921 ], [ -122.316783, 47.59845 ], [ -122.316711, 47.598743 ], [ -122.316501, 47.599066 ], [ -122.316401, 47.59917 ], [ -122.316242, 47.599159 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.23809523809523808 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321503, 47.598907 ], [ -122.321924, 47.59865 ], [ -122.322133, 47.598929 ], [ -122.322207, 47.599105 ], [ -122.322196, 47.600077 ], [ -122.321497, 47.599861 ], [ -122.321503, 47.598907 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318992, 47.598775 ], [ -122.31881, 47.598757 ], [ -122.318814, 47.597543 ], [ -122.319138, 47.597794 ], [ -122.319307, 47.59822 ], [ -122.319306, 47.598714 ], [ -122.319146, 47.598757 ], [ -122.318992, 47.598775 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315306, 47.60173 ], [ -122.315357, 47.60218 ], [ -122.315305, 47.602222 ], [ -122.31469, 47.602219 ], [ -122.314657, 47.60217 ], [ -122.314805, 47.601717 ], [ -122.315306, 47.60173 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313265, 47.601357 ], [ -122.313673, 47.601155 ], [ -122.313737, 47.601192 ], [ -122.313734, 47.602143 ], [ -122.313531, 47.60233 ], [ -122.313263, 47.601977 ], [ -122.313265, 47.601357 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322779, 47.597937 ], [ -122.322781, 47.597939 ], [ -122.322779, 47.598608 ], [ -122.32195, 47.598598 ], [ -122.321952, 47.597932 ], [ -122.322779, 47.597937 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31596, 47.606692 ], [ -122.314829, 47.606699 ], [ -122.314826, 47.606488 ], [ -122.314838, 47.606382 ], [ -122.315774, 47.606374 ], [ -122.31596, 47.606692 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.318394, 47.598841 ], [ -122.318401, 47.597155 ], [ -122.318432, 47.597102 ], [ -122.318438, 47.597097 ], [ -122.318814, 47.597543 ], [ -122.31881, 47.598757 ], [ -122.318438, 47.598875 ], [ -122.318394, 47.598841 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316519, 47.60572 ], [ -122.315891, 47.605717 ], [ -122.315889, 47.605712 ], [ -122.315894, 47.604713 ], [ -122.316054, 47.604775 ], [ -122.316542, 47.605389 ], [ -122.316541, 47.60565 ], [ -122.316519, 47.60572 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32094, 47.606639 ], [ -122.320323, 47.606633 ], [ -122.320436, 47.606314 ], [ -122.321092, 47.606357 ], [ -122.32094, 47.606639 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315952, 47.603061 ], [ -122.315472, 47.603174 ], [ -122.315299, 47.60305 ], [ -122.315305, 47.602222 ], [ -122.315357, 47.60218 ], [ -122.315886, 47.602182 ], [ -122.315958, 47.602212 ], [ -122.315952, 47.603061 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.53333333333333333 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327618, 47.602835 ], [ -122.327853, 47.602931 ], [ -122.327902, 47.603261 ], [ -122.32776, 47.604236 ], [ -122.326569, 47.603794 ], [ -122.327618, 47.602835 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311416, 47.605262 ], [ -122.312193, 47.605263 ], [ -122.312211, 47.605275 ], [ -122.312203, 47.606785 ], [ -122.31091, 47.606774 ], [ -122.310917, 47.605341 ], [ -122.311416, 47.605262 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316389, 47.601202 ], [ -122.316948, 47.601345 ], [ -122.316885, 47.601488 ], [ -122.316532, 47.601458 ], [ -122.316389, 47.601202 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.13333333333333333 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308978, 47.602678 ], [ -122.309305, 47.602161 ], [ -122.309348, 47.602158 ], [ -122.309609, 47.602347 ], [ -122.309624, 47.602389 ], [ -122.309625, 47.603042 ], [ -122.309574, 47.60311 ], [ -122.309267, 47.603106 ], [ -122.309226, 47.603103 ], [ -122.308978, 47.602678 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324799, 47.608114 ], [ -122.324231, 47.608012 ], [ -122.323999, 47.607452 ], [ -122.324014, 47.607376 ], [ -122.324186, 47.60723 ], [ -122.32451, 47.607201 ], [ -122.324886, 47.608104 ], [ -122.324799, 47.608114 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.320422, 47.602204 ], [ -122.321151, 47.602199 ], [ -122.321459, 47.602437 ], [ -122.321458, 47.602777 ], [ -122.320419, 47.602788 ], [ -122.320422, 47.602204 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323333, 47.606052 ], [ -122.322904, 47.605795 ], [ -122.323356, 47.605382 ], [ -122.323777, 47.605482 ], [ -122.32366, 47.605752 ], [ -122.323333, 47.606052 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316885, 47.601488 ], [ -122.316882, 47.601604 ], [ -122.316581, 47.601584 ], [ -122.316532, 47.601458 ], [ -122.316885, 47.601488 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316281, 47.60218 ], [ -122.316581, 47.60188 ], [ -122.317094, 47.601882 ], [ -122.317289, 47.602202 ], [ -122.317122, 47.602388 ], [ -122.31651, 47.602386 ], [ -122.316281, 47.60218 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316541, 47.596623 ], [ -122.318592, 47.596653 ], [ -122.318438, 47.597097 ], [ -122.318432, 47.597102 ], [ -122.316621, 47.597081 ], [ -122.316532, 47.596949 ], [ -122.316541, 47.596623 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308279, 47.606373 ], [ -122.307546, 47.606368 ], [ -122.307276, 47.606027 ], [ -122.306933, 47.605265 ], [ -122.30709, 47.605262 ], [ -122.308201, 47.605269 ], [ -122.308298, 47.605273 ], [ -122.308296, 47.606215 ], [ -122.308291, 47.606288 ], [ -122.308279, 47.606373 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326707, 47.601873 ], [ -122.326708, 47.601318 ], [ -122.32744, 47.601283 ], [ -122.327646, 47.60174 ], [ -122.327268, 47.602312 ], [ -122.32685, 47.602095 ], [ -122.326707, 47.601873 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.308329, 47.603105 ], [ -122.308656, 47.603103 ], [ -122.308947, 47.603521 ], [ -122.308776, 47.603767 ], [ -122.308324, 47.603813 ], [ -122.308329, 47.603105 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.25 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312031, 47.596961 ], [ -122.312191, 47.596903 ], [ -122.312211, 47.596932 ], [ -122.31221, 47.597378 ], [ -122.311977, 47.597772 ], [ -122.311746, 47.597728 ], [ -122.311625, 47.597493 ], [ -122.312031, 47.596961 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315304, 47.600865 ], [ -122.315306, 47.60173 ], [ -122.314805, 47.601717 ], [ -122.314806, 47.601605 ], [ -122.315243, 47.600837 ], [ -122.315304, 47.600865 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31217, 47.607426 ], [ -122.312167, 47.608628 ], [ -122.311907, 47.608644 ], [ -122.311839, 47.60861 ], [ -122.311842, 47.607705 ], [ -122.31217, 47.607426 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313709, 47.598518 ], [ -122.313133, 47.598964 ], [ -122.313076, 47.59898 ], [ -122.312981, 47.598954 ], [ -122.313035, 47.598665 ], [ -122.313424, 47.598383 ], [ -122.313709, 47.598518 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.46666666666666667 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32315, 47.608848 ], [ -122.322387, 47.609542 ], [ -122.32237, 47.609549 ], [ -122.322056, 47.609179 ], [ -122.322949, 47.608376 ], [ -122.32315, 47.608848 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.090909090909090912 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309626, 47.59987 ], [ -122.309572, 47.599808 ], [ -122.309464, 47.599542 ], [ -122.309415, 47.599367 ], [ -122.309413, 47.599117 ], [ -122.309478, 47.59889 ], [ -122.30987, 47.598088 ], [ -122.309919, 47.598116 ], [ -122.309948, 47.599556 ], [ -122.309705, 47.599827 ], [ -122.309626, 47.59987 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.46666666666666667 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321449, 47.607923 ], [ -122.320135, 47.607998 ], [ -122.320676, 47.607517 ], [ -122.321226, 47.607506 ], [ -122.321437, 47.607796 ], [ -122.321449, 47.607923 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.1388888888888889 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324069, 47.5992 ], [ -122.324096, 47.598775 ], [ -122.324722, 47.598779 ], [ -122.32472, 47.599439 ], [ -122.324584, 47.599608 ], [ -122.324197, 47.599606 ], [ -122.324174, 47.599569 ], [ -122.324086, 47.599389 ], [ -122.324069, 47.5992 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.321367, 47.600759 ], [ -122.321357, 47.600795 ], [ -122.320891, 47.600802 ], [ -122.320794, 47.600009 ], [ -122.321167, 47.599969 ], [ -122.321367, 47.600759 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324124, 47.605965 ], [ -122.324276, 47.606327 ], [ -122.324152, 47.606388 ], [ -122.323828, 47.606066 ], [ -122.32403, 47.605882 ], [ -122.324124, 47.605965 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323689, 47.603663 ], [ -122.325104, 47.602526 ], [ -122.325423, 47.60274 ], [ -122.324341, 47.604064 ], [ -122.323689, 47.60367 ], [ -122.323689, 47.603663 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323315, 47.604594 ], [ -122.32344, 47.603899 ], [ -122.323689, 47.60367 ], [ -122.324341, 47.604064 ], [ -122.324492, 47.604251 ], [ -122.32393, 47.604767 ], [ -122.32361, 47.604776 ], [ -122.323315, 47.604594 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.315777, 47.607775 ], [ -122.315775, 47.608362 ], [ -122.314818, 47.608363 ], [ -122.31482, 47.607762 ], [ -122.315777, 47.607775 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313568, 47.59756 ], [ -122.31346, 47.597205 ], [ -122.313487, 47.597167 ], [ -122.314377, 47.59703 ], [ -122.314378, 47.597964 ], [ -122.313745, 47.597855 ], [ -122.313732, 47.597844 ], [ -122.313568, 47.59756 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.35714285714285715 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324448, 47.606327 ], [ -122.324736, 47.606998 ], [ -122.32451, 47.607201 ], [ -122.324186, 47.60723 ], [ -122.323926, 47.60659 ], [ -122.324152, 47.606388 ], [ -122.324276, 47.606327 ], [ -122.324448, 47.606327 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310614, 47.607094 ], [ -122.311216, 47.607709 ], [ -122.311214, 47.608604 ], [ -122.311185, 47.608621 ], [ -122.310555, 47.608625 ], [ -122.310559, 47.607112 ], [ -122.310614, 47.607094 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313907, 47.59925 ], [ -122.313908, 47.59961 ], [ -122.313832, 47.599653 ], [ -122.313552, 47.599605 ], [ -122.313076, 47.59898 ], [ -122.313133, 47.598964 ], [ -122.313658, 47.598993 ], [ -122.313907, 47.59925 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32375, 47.607679 ], [ -122.323973, 47.608213 ], [ -122.3238, 47.608395 ], [ -122.323551, 47.6078 ], [ -122.32375, 47.607679 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5357142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316501, 47.599066 ], [ -122.317387, 47.599067 ], [ -122.317391, 47.599624 ], [ -122.317059, 47.599616 ], [ -122.316701, 47.599468 ], [ -122.316472, 47.599261 ], [ -122.316401, 47.59917 ], [ -122.316501, 47.599066 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311216, 47.598859 ], [ -122.311962, 47.598859 ], [ -122.311723, 47.599068 ], [ -122.311394, 47.599068 ], [ -122.311216, 47.598859 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311533, 47.603905 ], [ -122.312076, 47.603747 ], [ -122.312199, 47.603935 ], [ -122.312193, 47.605263 ], [ -122.311416, 47.605262 ], [ -122.311421, 47.603947 ], [ -122.311533, 47.603905 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.324197, 47.599606 ], [ -122.324162, 47.599662 ], [ -122.323195, 47.599656 ], [ -122.32331, 47.599563 ], [ -122.324174, 47.599569 ], [ -122.324197, 47.599606 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312904, 47.602681 ], [ -122.313154, 47.603098 ], [ -122.313123, 47.6031 ], [ -122.312609, 47.603095 ], [ -122.312874, 47.60268 ], [ -122.312904, 47.602681 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.16666666666666666 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312867, 47.603519 ], [ -122.312621, 47.603928 ], [ -122.312519, 47.603934 ], [ -122.312199, 47.603935 ], [ -122.312076, 47.603747 ], [ -122.312076, 47.603287 ], [ -122.312204, 47.603095 ], [ -122.312533, 47.603099 ], [ -122.312867, 47.603519 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317111, 47.60539 ], [ -122.317113, 47.604781 ], [ -122.317779, 47.604781 ], [ -122.317782, 47.604783 ], [ -122.317779, 47.605708 ], [ -122.317299, 47.605706 ], [ -122.317254, 47.605647 ], [ -122.317111, 47.60539 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316127, 47.607322 ], [ -122.316129, 47.606995 ], [ -122.316131, 47.606986 ], [ -122.317558, 47.606994 ], [ -122.317752, 47.607133 ], [ -122.317591, 47.60736 ], [ -122.31614, 47.607369 ], [ -122.316127, 47.607322 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316711, 47.598743 ], [ -122.317625, 47.598744 ], [ -122.317654, 47.598771 ], [ -122.317387, 47.599067 ], [ -122.316501, 47.599066 ], [ -122.316711, 47.598743 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.7142857142857143 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.326697, 47.60046 ], [ -122.326691, 47.601304 ], [ -122.32603, 47.601294 ], [ -122.325497, 47.60087 ], [ -122.326031, 47.600458 ], [ -122.326694, 47.600458 ], [ -122.326697, 47.60046 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.313432, 47.597207 ], [ -122.312695, 47.597843 ], [ -122.31221, 47.597378 ], [ -122.312211, 47.596932 ], [ -122.313432, 47.597207 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322056, 47.609179 ], [ -122.32186, 47.609008 ], [ -122.321823, 47.608851 ], [ -122.322935, 47.607825 ], [ -122.323047, 47.608104 ], [ -122.322949, 47.608376 ], [ -122.322056, 47.609179 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.38095238095238093 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323828, 47.606066 ], [ -122.323788, 47.606061 ], [ -122.32366, 47.605752 ], [ -122.323777, 47.605482 ], [ -122.323852, 47.605455 ], [ -122.32403, 47.605882 ], [ -122.323828, 47.606066 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.307941, 47.603921 ], [ -122.307985, 47.603925 ], [ -122.307684, 47.60432 ], [ -122.307655, 47.60432 ], [ -122.307333, 47.603923 ], [ -122.307388, 47.603918 ], [ -122.307941, 47.603921 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314838, 47.606382 ], [ -122.314826, 47.606488 ], [ -122.313481, 47.606487 ], [ -122.31351, 47.606302 ], [ -122.314825, 47.606298 ], [ -122.314838, 47.606382 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.14285714285714285 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.32195, 47.598598 ], [ -122.322779, 47.598608 ], [ -122.322866, 47.598729 ], [ -122.322771, 47.598926 ], [ -122.322133, 47.598929 ], [ -122.321924, 47.59865 ], [ -122.32195, 47.598598 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.311563, 47.609209 ], [ -122.311902, 47.608721 ], [ -122.3119, 47.609515 ], [ -122.311695, 47.609441 ], [ -122.311563, 47.609209 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.083333333333333329 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312462, 47.608631 ], [ -122.312502, 47.608975 ], [ -122.3125, 47.609718 ], [ -122.3125, 47.609731 ], [ -122.3119, 47.609515 ], [ -122.311902, 47.608721 ], [ -122.311907, 47.608644 ], [ -122.312167, 47.608628 ], [ -122.312462, 47.608631 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.054545454545454543 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317299, 47.605706 ], [ -122.317779, 47.605708 ], [ -122.317782, 47.60571 ], [ -122.31778, 47.607124 ], [ -122.317752, 47.607133 ], [ -122.317558, 47.606994 ], [ -122.31727, 47.606691 ], [ -122.317109, 47.606377 ], [ -122.31711, 47.606035 ], [ -122.317236, 47.605792 ], [ -122.317299, 47.605706 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.4 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.312895, 47.604339 ], [ -122.313352, 47.60517 ], [ -122.313242, 47.605291 ], [ -122.312298, 47.605274 ], [ -122.312866, 47.604342 ], [ -122.312895, 47.604339 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.3 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.31958, 47.609034 ], [ -122.321832, 47.609022 ], [ -122.321222, 47.609483 ], [ -122.319118, 47.609491 ], [ -122.31958, 47.609034 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.17857142857142858 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309941, 47.607105 ], [ -122.309938, 47.60856 ], [ -122.3096, 47.608373 ], [ -122.309155, 47.608007 ], [ -122.3097, 47.607193 ], [ -122.309853, 47.607103 ], [ -122.309931, 47.607101 ], [ -122.309941, 47.607105 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316131, 47.606986 ], [ -122.316129, 47.606995 ], [ -122.314773, 47.60698 ], [ -122.314829, 47.606699 ], [ -122.31596, 47.606692 ], [ -122.316131, 47.60685 ], [ -122.316131, 47.606986 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.66666666666666663 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317798, 47.609396 ], [ -122.316397, 47.609391 ], [ -122.3164, 47.60898 ], [ -122.317732, 47.608976 ], [ -122.317994, 47.609263 ], [ -122.317798, 47.609396 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 1.0 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.322771, 47.598926 ], [ -122.322731, 47.599105 ], [ -122.322207, 47.599105 ], [ -122.322133, 47.598929 ], [ -122.322771, 47.598926 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.33333333333333331 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.327184, 47.605077 ], [ -122.327344, 47.605455 ], [ -122.327086, 47.606027 ], [ -122.326987, 47.606153 ], [ -122.326558, 47.605139 ], [ -122.327184, 47.605077 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.5 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.317453, 47.60835 ], [ -122.317527, 47.60859 ], [ -122.3166, 47.608592 ], [ -122.316655, 47.608353 ], [ -122.317453, 47.60835 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.6 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.316959, 47.600228 ], [ -122.317054, 47.600076 ], [ -122.318145, 47.600411 ], [ -122.318146, 47.600498 ], [ -122.316959, 47.600228 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2857142857142857 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.30935, 47.601264 ], [ -122.308314, 47.601261 ], [ -122.307765, 47.600418 ], [ -122.309558, 47.600431 ], [ -122.30959, 47.600533 ], [ -122.309588, 47.601042 ], [ -122.30935, 47.601264 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.054545454545454543 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.309615, 47.604075 ], [ -122.3091, 47.60414 ], [ -122.308807, 47.604136 ], [ -122.308314, 47.604061 ], [ -122.308278, 47.603932 ], [ -122.308324, 47.603813 ], [ -122.308776, 47.603767 ], [ -122.30913, 47.603769 ], [ -122.309576, 47.603824 ], [ -122.309639, 47.603988 ], [ -122.309615, 47.604075 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.47619047619047616 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.314813, 47.609767 ], [ -122.314426, 47.610216 ], [ -122.313744, 47.610076 ], [ -122.313746, 47.608628 ], [ -122.314686, 47.608636 ], [ -122.314815, 47.608947 ], [ -122.314813, 47.609767 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.2 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.323195, 47.599656 ], [ -122.324162, 47.599662 ], [ -122.324098, 47.599799 ], [ -122.323091, 47.59978 ], [ -122.323191, 47.599658 ], [ -122.323195, 47.599656 ] ] ] ] } }, +{ "type": "Feature", "properties": { "tra_score": 0.10714285714285714 }, "geometry": { "type": "MultiPolygon", "coordinates": [ [ [ [ -122.310749, 47.602516 ], [ -122.309624, 47.602389 ], [ -122.309609, 47.602347 ], [ -122.309872, 47.602093 ], [ -122.309907, 47.602076 ], [ -122.310921, 47.602091 ], [ -122.310925, 47.602129 ], [ -122.310749, 47.602516 ] ] ] ] } } +] +}